Reference documentation for deal.II version 9.3.3
\(\newcommand{\dealvcentcolon}{\mathrel{\mathop{:}}}\) \(\newcommand{\dealcoloneq}{\dealvcentcolon\mathrel{\mkern-1.2mu}=}\) \(\newcommand{\jump}[1]{\left[\!\left[ #1 \right]\!\right]}\) \(\newcommand{\average}[1]{\left\{\!\left\{ #1 \right\}\!\right\}}\)
Deprecated List
Member CellAccessor< dim, spacedim >::active () const
This function is deprecated. Use the is_active() function instead, which satisfies the naming scheme of other functions inquiring about yes/no properties of cells (e.g., is_ghost(), is_locally_owned(), etc.).
Member CellId::to_cell (const Triangulation< dim, spacedim > &tria) const
Use Triangulation::create_cell_iterator() instead.
Member ConstantFunction
use Functions::ConstantFunction instead.
Member CUDAWrappers::FEEvaluation< dim, fe_degree, n_q_points_1d, n_components_, Number >::apply_quad_point_operations (const Functor &func)
Use apply_for_each_quad_point() instead.
Member CUDAWrappers::FEEvaluation< dim, fe_degree, n_q_points_1d, n_components_, Number >::get_dof_value (const unsigned int dof) const
Use the version without parameters instead.
Member CUDAWrappers::FEEvaluation< dim, fe_degree, n_q_points_1d, n_components_, Number >::get_gradient (const unsigned int q_point) const
Use the version without parameters instead.
Member CUDAWrappers::FEEvaluation< dim, fe_degree, n_q_points_1d, n_components_, Number >::get_value (const unsigned int q_point) const
Use the version without parameters instead.
Member CUDAWrappers::FEEvaluation< dim, fe_degree, n_q_points_1d, n_components_, Number >::submit_dof_value (const value_type &val_in, const unsigned int dof)
Use the version without parameters instead.
Member CUDAWrappers::FEEvaluation< dim, fe_degree, n_q_points_1d, n_components_, Number >::submit_gradient (const gradient_type &grad_in, const unsigned int q_point)
Use the version without parameters instead.
Member CUDAWrappers::FEEvaluation< dim, fe_degree, n_q_points_1d, n_components_, Number >::submit_value (const value_type &val_in, const unsigned int q_point)
Use the version without parameters instead.
Member DataOut< dim, DoFHandlerType >::first_cell ()
Use the set_cell_selection() function instead.
Member DataOut< dim, DoFHandlerType >::first_locally_owned_cell ()
Use the set_cell_selection() function instead.
Member DataOut< dim, DoFHandlerType >::next_cell (const cell_iterator &cell)
Use the set_cell_selection() function instead.
Member DataOut< dim, DoFHandlerType >::next_locally_owned_cell (const cell_iterator &cell)
Use the set_cell_selection() function instead.
Member DataOutBase::default_suffix (const OutputFormat output_format)
Using Tecplot binary output is deprecated.
Member DataOutBase::tecplot_binary
Using Tecplot binary output is deprecated.
Class DataOutStack< dim, spacedim, DoFHandlerType >
Use DataOutStack<dim, spacedim> instead.
Member DataPostprocessorInputs::CommonInputs< spacedim >::get_cell () const
Use the equivalent function with the dim template parameter instead.
Member DataPostprocessorInputs::CommonInputs< spacedim >::set_cell (const typename DoFHandlerType::cell_iterator &cell)
Use the equivalent function with the dim template parameter instead.
Member DoFHandler< dim, spacedim >::initialize (const Triangulation< dim, spacedim > &tria, const FiniteElement< dim, spacedim > &fe)
Use reinit() and distribute_dofs() instead.
Member DoFHandler< dim, spacedim >::initialize (const Triangulation< dim, spacedim > &tria, const hp::FECollection< dim, spacedim > &fe)
Use reinit() and distribute_dofs() instead.
Member DoFHandler< dim, spacedim >::locally_owned_dofs_per_processor () const
As of deal.II version 9.2, we do not populate a vector with the index sets of all processors by default any more due to a possibly large memory footprint on many processors. As a consequence, this function needs to call Utilities::MPI::all_gather(comm, locally_owned_dofs()) upon the first invocation, including global communication. Use Utilities::MPI::all_gather(comm, dof_handler.locally_owned_dofs()) instead if using up to a few thousands of MPI ranks or some variant involving local communication with more processors.
Member DoFHandler< dim, spacedim >::locally_owned_mg_dofs_per_processor (const unsigned int level) const
As of deal.II version 9.2, we do not populate a vector with the index sets of all processors by default any more due to a possibly large memory footprint on many processors. As a consequence, this function needs to call Utilities::MPI::all_gather(comm, locally_owned_dofs_mg()) upon the first invocation, including global communication. Use Utilities::MPI::all_gather(comm, dof_handler.locally_owned_dofs_mg()) instead if using up to a few thousands of MPI ranks or some variant involving local communication with more processors.
Member DoFHandler< dim, spacedim >::n_locally_owned_dofs_per_processor () const
As of deal.II version 9.2, we do not populate a vector with the numbers of dofs of all processors by default any more due to a possibly large memory footprint on many processors. As a consequence, this function needs to call Utilities::MPI::all_gather(comm, n_locally_owned_dofs() upon the first invocation, including global communication. Use Utilities::MPI::all_gather(comm, dof_handler.n_locally_owned_dofs() instead if using up to a few thousands of MPI ranks or some variant involving local communication with more processors.
Member DoFHandler< dim, spacedim >::set_fe (const hp::FECollection< dim, spacedim > &fe)
Use distribute_dofs() instead.
Member DoFHandler< dim, spacedim >::set_fe (const FiniteElement< dim, spacedim > &fe)
Use distribute_dofs() instead.
Member DoFTools::count_dofs_on_patch (const std::vector< typename DoFHandlerType::active_cell_iterator > &patch)
Use the function that takes dim and spacedim as template argument.
Member DoFTools::count_dofs_per_block (const DoFHandler< dim, spacedim > &dof, std::vector< types::global_dof_index > &dofs_per_block, const std::vector< unsigned int > &target_block=std::vector< unsigned int >())
A version of the previous function that returns its information through the non-const second argument.
Member DoFTools::count_dofs_per_component (const DoFHandler< dim, spacedim > &dof_handler, std::vector< types::global_dof_index > &dofs_per_component, const bool vector_valued_once=false, const std::vector< unsigned int > &target_component={})
A version of the previous function that returns its information through the non-const second argument.
Member DoFTools::extract_boundary_dofs (const DoFHandler< dim, spacedim > &dof_handler, const ComponentMask &component_mask, std::vector< bool > &selected_dofs, const std::set< types::boundary_id > &boundary_ids={})
This function will not work for DoFHandler objects that are built on a parallel::distributed::Triangulation object. The reasons is that the output argument selected_dofs has to have a length equal to all global degrees of freedom. Consequently, this does not scale to very large problems, and this is also why the function is deprecated. If you need the functionality of this function for parallel triangulations, then you need to use the other DoFTools::extract_boundary_dofs() function that returns its information via an IndexSet object.
Member DoFTools::extract_boundary_dofs (const DoFHandler< dim, spacedim > &dof_handler, const ComponentMask &component_mask, IndexSet &selected_dofs, const std::set< types::boundary_id > &boundary_ids={})
Use the previous function instead.
Member DoFTools::extract_dofs (const DoFHandler< dim, spacedim > &dof_handler, const ComponentMask &component_mask, std::vector< bool > &selected_dofs)
This function is difficult to use in parallel contexts because it returns a vector that needs to be indexed based on the position of a degree of freedom within the set of locally owned degrees of freedom. It is consequently deprecated in favor of the following function.
Member DoFTools::extract_dofs (const DoFHandler< dim, spacedim > &dof_handler, const BlockMask &block_mask, std::vector< bool > &selected_dofs)
This function is difficult to use in parallel contexts because it returns a vector that needs to be indexed based on the position of a degree of freedom within the set of locally owned degrees of freedom. It is consequently deprecated in favor of the following function.
Member DoFTools::extract_hanging_node_dofs (const DoFHandler< dim, spacedim > &dof_handler, std::vector< bool > &selected_dofs)
For the reason stated above, this function is deprecated in favor of the following function.
Member DoFTools::get_dofs_on_patch (const std::vector< typename DoFHandlerType::active_cell_iterator > &patch)
Use the function that takes dim and spacedim as template argument.
Member DoFTools::make_periodicity_constraints (const std::vector< GridTools::PeriodicFacePair< typename DoFHandlerType::cell_iterator > > &periodic_faces, AffineConstraints< number > &constraints, const ComponentMask &component_mask=ComponentMask(), const std::vector< unsigned int > &first_vector_components=std::vector< unsigned int >(), const number periodicity_factor=1.)
Use the function that takes dim and spacedim as template argument.
Member FEEvaluation< dim, fe_degree, n_q_points_1d, n_components_, Number, VectorizedArrayType >::evaluate (const VectorizedArrayType *values_array, const bool evaluate_values, const bool evaluate_gradients, const bool evaluate_hessians=false)
use evaluate() with the EvaluationFlags argument.
Member FEEvaluation< dim, fe_degree, n_q_points_1d, n_components_, Number, VectorizedArrayType >::evaluate (const bool evaluate_values, const bool evaluate_gradients, const bool evaluate_hessians=false)
use evaluate() with the EvaluationFlags argument.
Member FEEvaluation< dim, fe_degree, n_q_points_1d, n_components_, Number, VectorizedArrayType >::gather_evaluate (const VectorType &input_vector, const bool evaluate_values, const bool evaluate_gradients, const bool evaluate_hessians=false)
Please use the gather_evaluate() function with the EvaluationFlags argument.
Member FEEvaluation< dim, fe_degree, n_q_points_1d, n_components_, Number, VectorizedArrayType >::integrate (const bool integrate_values, const bool integrate_gradients, VectorizedArrayType *values_array)
Please use the integrate() function with the EvaluationFlags argument.
Member FEEvaluation< dim, fe_degree, n_q_points_1d, n_components_, Number, VectorizedArrayType >::integrate (const bool integrate_values, const bool integrate_gradients)
Please use the integrate() function with the EvaluationFlags argument.
Member FEEvaluation< dim, fe_degree, n_q_points_1d, n_components_, Number, VectorizedArrayType >::integrate_scatter (const bool integrate_values, const bool integrate_gradients, VectorType &output_vector)
Please use the integrate_scatter() function with the EvaluationFlags argument.
Member FEFaceEvaluation< dim, fe_degree, n_q_points_1d, n_components_, Number, VectorizedArrayType >::evaluate (const VectorizedArrayType *values_array, const bool evaluate_values, const bool evaluate_gradients)
Please use the evaluate() function with the EvaluationFlags argument.
Member FEFaceEvaluation< dim, fe_degree, n_q_points_1d, n_components_, Number, VectorizedArrayType >::evaluate (const bool evaluate_values, const bool evaluate_gradients)
Please use the evaluate() function with the EvaluationFlags argument.
Member FEFaceEvaluation< dim, fe_degree, n_q_points_1d, n_components_, Number, VectorizedArrayType >::gather_evaluate (const VectorType &input_vector, const bool evaluate_values, const bool evaluate_gradients)
Please use the gather_evaluate() function with the EvaluationFlags argument.
Member FEFaceEvaluation< dim, fe_degree, n_q_points_1d, n_components_, Number, VectorizedArrayType >::integrate (const bool integrate_values, const bool integrate_gradients)
Please use the integrate() function with the EvaluationFlags argument.
Member FEFaceEvaluation< dim, fe_degree, n_q_points_1d, n_components_, Number, VectorizedArrayType >::integrate (const bool integrate_values, const bool integrate_gradients, VectorizedArrayType *values_array)
Please use the integrate() function with the EvaluationFlags argument.
Member FEFaceEvaluation< dim, fe_degree, n_q_points_1d, n_components_, Number, VectorizedArrayType >::integrate_scatter (const bool integrate_values, const bool integrate_gradients, VectorType &output_vector)
Please use the integrate_scatter() function with the EvaluationFlags argument.
Member FESeries::Fourier< dim, spacedim >::Fourier (const unsigned int n_coefficients_per_direction, const hp::FECollection< dim, spacedim > &fe_collection, const hp::QCollection< dim > &q_collection)
Use a different constructor instead.
Member FESeries::Legendre< dim, spacedim >::Legendre (const unsigned int n_coefficients_per_direction, const hp::FECollection< dim, spacedim > &fe_collection, const hp::QCollection< dim > &q_collection)
Use a different constructor instead.
Member FETools::hierarchic_to_lexicographic_numbering (const FiniteElementData< dim > &fe_data)
Use the function that uses the degree of the basis as an argument instead.
Member FETools::hierarchic_to_lexicographic_numbering (unsigned int degree, std::vector< unsigned int > &h2l)
Use the function that returns the renumbering in a vector instead.
Member FETools::hierarchic_to_lexicographic_numbering (const FiniteElementData< dim > &fe_data, std::vector< unsigned int > &h2l)
Use the function that returns the renumbering in a vector and uses the degree of the basis as an argument instead.
Member FETools::lexicographic_to_hierarchic_numbering (const FiniteElementData< dim > &fe_data, std::vector< unsigned int > &l2h)
Use the function that returns the renumbering in a vector and uses the degree of the basis as an argument instead.
Member FETools::lexicographic_to_hierarchic_numbering (const FiniteElementData< dim > &fe_data)
Use the function that uses the degree of the basis as an argument instead.
Class FEValuesViews::Scalar< dim, spacedim >::OutputType< Number >
Use the types defined in the surrounding class instead.
Class FEValuesViews::SymmetricTensor< 2, dim, spacedim >::OutputType< Number >
Use the types defined in the surrounding class instead.
Class FEValuesViews::Tensor< 2, dim, spacedim >::OutputType< Number >
Use the types defined in the surrounding class instead.
Class FEValuesViews::Vector< dim, spacedim >::OutputType< Number >
Use the types defined in the surrounding class instead.
Member FiniteElement< dim, spacedim >::fill_fe_face_values (const typename Triangulation< dim, spacedim >::cell_iterator &cell, const unsigned int face_no, const Quadrature< dim - 1 > &quadrature, const Mapping< dim, spacedim > &mapping, const typename Mapping< dim, spacedim >::InternalDataBase &mapping_internal, const internal::FEValuesImplementation::MappingRelatedData< dim, spacedim > &mapping_data, const InternalDataBase &fe_internal, internal::FEValuesImplementation::FiniteElementRelatedData< dim, spacedim > &output_data) const
Use the version taking a hp::QCollection argument.
Member FiniteElement< dim, spacedim >::get_face_data (const UpdateFlags update_flags, const Mapping< dim, spacedim > &mapping, const Quadrature< dim - 1 > &quadrature, internal::FEValuesImplementation::FiniteElementRelatedData< dim, spacedim > &output_data) const
Use the version taking a hp::QCollection argument.
Member FiniteElement< dim, spacedim >::operator[] (const unsigned int fe_index) const
With DoFHandler::get_fe(int) and the deprecation of the hp::DoFHandler class, there is no more use of this operator.
Class GridReordering< dim, spacedim >
Use GridTools::invert_all_negative_measure_cells() or GridTools::consistently_order_cells() instead of the functions provided by this class. Usage of the old-style numbering is deprecated.
Member GridReordering< dim, spacedim >::invert_all_cells_of_negative_grid (const std::vector< Point< spacedim > > &all_vertices, std::vector< CellData< dim > > &original_cells, const bool use_new_style_ordering=false)
Use GridTools::invert_all_negative_measure_cells() instead.
Member GridReordering< dim, spacedim >::reorder_cells (std::vector< CellData< dim > > &original_cells, const bool use_new_style_ordering=false)
Use GridTools::consistently_order_cells() instead.
Member GridTools::cell_measure (const std::vector< Point< dim > > &all_vertices, const unsigned int(&vertex_indices)[GeometryInfo< dim >::vertices_per_cell])
Use the more general function which takes an ArrayView instead.
Class hp::DoFHandler< dim, spacedim >
The basic DoFHandler is capable of hp-adaptation now.
Member LinearAlgebra::CUDAWrappers::atomicAdd_wrapper (float *address, float val)

Use atomicAdd(address, val) directly.

Member LinearAlgebra::CUDAWrappers::atomicAdd_wrapper (double *address, double val)

Use atomicAdd(address, val) directly.

Member LinearAlgebra::distributed::BlockVector< Number >::zero_out_ghosts () const
Use zero_out_ghost_values() instead.
Member LinearAlgebra::distributed::Vector< Number, MemorySpace >::local_size () const
Use locally_owned_size() instead.
Member LinearAlgebra::distributed::Vector< Number, MemorySpace >::zero_out_ghosts () const
Use zero_out_ghost_values() instead.
Member LinearAlgebra::ReadWriteVector< Number >::n_elements () const
use locally_owned_size() instead.
Member Mapping< dim, spacedim >::fill_fe_face_values (const typename Triangulation< dim, spacedim >::cell_iterator &cell, const unsigned int face_no, const Quadrature< dim - 1 > &quadrature, const typename Mapping< dim, spacedim >::InternalDataBase &internal_data, internal::FEValuesImplementation::MappingRelatedData< dim, spacedim > &output_data) const
Use the version taking a hp::QCollection argument.
Member Mapping< dim, spacedim >::get_face_data (const UpdateFlags update_flags, const Quadrature< dim - 1 > &quadrature) const
Use the version taking a hp::QCollection argument.
Class MappingFEField< dim, spacedim, VectorType, DoFHandlerType >
Use MappingFEField<dim, spacedim, VectorType> instead.
Member MappingQCache< dim, spacedim >::initialize (const Triangulation< dim, spacedim > &triangulation, const MappingQGeneric< dim, spacedim > &mapping)
Use initialize() version above instead.
Member MatrixFree< dim, Number, VectorizedArrayType >::AdditionalData::level_mg_handler
Use mg_level instead.
Member MatrixFree< dim, Number, VectorizedArrayType >::get_dof_handler (const unsigned int dof_handler_index=0) const
Use the non-templated equivalent of this function.
Member MatrixFree< dim, Number, VectorizedArrayType >::get_hp_cell_iterator (const unsigned int cell_batch_index, const unsigned int lane_index, const unsigned int dof_handler_index=0) const
Use get_cell_iterator() instead.
Member MatrixFree< dim, Number, VectorizedArrayType >::n_components_filled (const unsigned int cell_batch_number) const
Use n_active_entries_per_cell_batch() instead.
Member MatrixFree< dim, Number, VectorizedArrayType >::n_macro_cells () const
Use n_cell_batches() instead.
Member MatrixFree< dim, Number, VectorizedArrayType >::reinit (const MappingType &mapping, const std::vector< const DoFHandlerType * > &dof_handler, const std::vector< const AffineConstraints< number2 > * > &constraint, const std::vector< QuadratureType > &quad, const AdditionalData &additional_data=AdditionalData())
Use the overload taking a DoFHandler object instead.
Member MatrixFree< dim, Number, VectorizedArrayType >::reinit (const std::vector< const DoFHandler< dim > * > &dof_handler, const std::vector< const AffineConstraints< number2 > * > &constraint, const std::vector< QuadratureType > &quad, const AdditionalData &additional_data=AdditionalData())
Use the overload taking a Mapping object instead.
Member MatrixFree< dim, Number, VectorizedArrayType >::reinit (const std::vector< const DoFHandlerType * > &dof_handler, const std::vector< const AffineConstraints< number2 > * > &constraint, const std::vector< QuadratureType > &quad, const AdditionalData &additional_data=AdditionalData())
Use the overload taking a DoFHandler object instead.
Member MatrixFree< dim, Number, VectorizedArrayType >::reinit (const MappingType &mapping, const std::vector< const DoFHandlerType * > &dof_handler, const std::vector< const AffineConstraints< number2 > * > &constraint, const QuadratureType &quad, const AdditionalData &additional_data=AdditionalData())
Use the overload taking a DoFHandler object instead.
Member MatrixFree< dim, Number, VectorizedArrayType >::reinit (const std::vector< const DoFHandler< dim > * > &dof_handler, const std::vector< const AffineConstraints< number2 > * > &constraint, const QuadratureType &quad, const AdditionalData &additional_data=AdditionalData())
Use the overload taking a Mapping object instead.
Member MatrixFree< dim, Number, VectorizedArrayType >::reinit (const std::vector< const DoFHandlerType * > &dof_handler, const std::vector< const AffineConstraints< number2 > * > &constraint, const QuadratureType &quad, const AdditionalData &additional_data=AdditionalData())
Use the overload taking a DoFHandler object instead.
Member MatrixFree< dim, Number, VectorizedArrayType >::reinit (const DoFHandler< dim > &dof_handler, const AffineConstraints< number2 > &constraint, const QuadratureType &quad, const AdditionalData &additional_data=AdditionalData())
Use the overload taking a Mapping object instead.
Member MGTransferBlock< number >::build_matrices (const DoFHandler< dim, spacedim > &dof, const DoFHandler< dim, spacedim > &mg_dof, const std::vector< bool > &selected)
Use the build() function instead.
Member MGTransferBlockBase::build_matrices (const DoFHandler< dim, spacedim > &dof, const DoFHandler< dim, spacedim > &mg_dof)
Use build() instead.
Member MGTransferBlockSelect< number >::build_matrices (const DoFHandler< dim, spacedim > &dof, const DoFHandler< dim, spacedim > &mg_dof, unsigned int selected)
Use build() instead.
Member MGTransferComponentBase::build_matrices (const DoFHandler< dim, spacedim > &dof, const DoFHandler< dim, spacedim > &mg_dof)
Use build() instead.
Member MGTransferPrebuilt< VectorType >::build_matrices (const DoFHandler< dim, spacedim > &dof_handler)
use build() instead.
Member MGTransferSelect< number >::build_matrices (const DoFHandler< dim, spacedim > &dof, const DoFHandler< dim, spacedim > &mg_dof, unsigned int selected, unsigned int mg_selected, const std::vector< unsigned int > &target_component=std::vector< unsigned int >(), const std::vector< unsigned int > &mg_target_component=std::vector< unsigned int >(), const std::vector< std::set< types::global_dof_index > > &boundary_indices=std::vector< std::set< types::global_dof_index > >())
Use build() instead.
Member parallel::CellWeights< dim, spacedim >::register_constant_weighting (const unsigned int factor=1000)
Use CellWeights::constant_weighting() instead.
Member parallel::CellWeights< dim, spacedim >::register_ndofs_squared_weighting (const unsigned int factor=1000)
Use CellWeights::ndofs_weighting() instead.
Member parallel::CellWeights< dim, spacedim >::register_ndofs_weighting (const unsigned int factor=1000)
Use CellWeights::ndofs_weighting() instead.
Member parallel::distributed::BlockVector
Use LinearAlgebra::distributed::BlockVector instead.
Member parallel::distributed::CellDataTransfer< dim, spacedim, VectorType >::CellDataTransfer (const parallel::distributed::Triangulation< dim, spacedim > &triangulation, const bool transfer_variable_size_data, const std::function< value_type(const typename parallel::distributed::Triangulation< dim, spacedim >::cell_iterator &parent, const VectorType &input_vector)> coarsening_strategy)
Use the above constructor instead.
Class parallel::distributed::CellDataTransfer< dim, spacedim, VectorType >::CoarseningStrategies
Use the namespace AdaptationStrategies::Coarsening instead.
Member parallel::distributed::CellDataTransfer< dim, spacedim, VectorType >::CoarseningStrategies::check_equality (const typename parallel::distributed::Triangulation< dim, spacedim >::cell_iterator &parent, const VectorType &input_vector)
Use AdaptationStrategies::Coarsening::check_equality() instead.
Member parallel::distributed::CellDataTransfer< dim, spacedim, VectorType >::CoarseningStrategies::mean (const typename parallel::distributed::Triangulation< dim, spacedim >::cell_iterator &parent, const VectorType &input_vector)
Use AdaptationStrategies::Coarsening::mean() instead.
Member parallel::distributed::CellDataTransfer< dim, spacedim, VectorType >::CoarseningStrategies::sum (const typename parallel::distributed::Triangulation< dim, spacedim >::cell_iterator &parent, const VectorType &input_vector)
Use AdaptationStrategies::Coarsening::sum() instead.
Member parallel::Triangulation
Use TriangulationBase instead of Triangulation.
Member parallel::TriangulationBase< dim, spacedim >::compute_vertices_with_ghost_neighbors () const
Use GridTools::compute_vertices_with_ghost_neighbors() instead of parallel::TriangulationBase::compute_vertices_with_ghost_neighbors().
Member ParameterHandler::ExcInvalidEntryForPatternXML
Use ExcValueDoesNotMatchPattern instead of ExcInvalidEntryForPatternXML.
Member ParameterHandler::ShortText
Use ShortPRM instead of ShortText.
Member ParameterHandler::Text
Use PRM instead of Text.
Member Particles::ParticleHandler< dim, spacedim >::locally_relevant_ids () const
Use locally_owned_particle_ids() instead.
Member PETScWrappers::MatrixBase::add (const MatrixBase &other, const PetscScalar factor)
Use the function with order of arguments reversed instead.
Member PETScWrappers::MPI::SparseMatrix::do_reinit (const size_type m, const size_type n, const size_type local_rows, const size_type local_columns, const size_type n_nonzero_per_row, const bool is_symmetric=false, const size_type n_offdiag_nonzero_per_row=0)
This overload of do_reinit is deprecated: please use the overload with a sparsity pattern argument instead.
Member PETScWrappers::MPI::SparseMatrix::do_reinit (const size_type m, const size_type n, const size_type local_rows, const size_type local_columns, const std::vector< size_type > &row_lengths, const bool is_symmetric=false, const std::vector< size_type > &offdiag_row_lengths=std::vector< size_type >())
This overload of do_reinit is deprecated: please use the overload with a sparsity pattern argument instead.
Member PETScWrappers::MPI::SparseMatrix::reinit (const MPI_Comm &communicator, const size_type m, const size_type n, const size_type local_rows, const size_type local_columns, const std::vector< size_type > &row_lengths, const bool is_symmetric=false, const std::vector< size_type > &offdiag_row_lengths=std::vector< size_type >())
This overload of reinit is deprecated: please use the overload with a sparsity pattern argument instead.
Member PETScWrappers::MPI::SparseMatrix::reinit (const MPI_Comm &communicator, const size_type m, const size_type n, const size_type local_rows, const size_type local_columns, const size_type n_nonzero_per_row, const bool is_symmetric=false, const size_type n_offdiag_nonzero_per_row=0)
This overload of reinit is deprecated: please use the overload with a sparsity pattern argument instead.
Member PETScWrappers::MPI::SparseMatrix::SparseMatrix (const MPI_Comm &communicator, const size_type m, const size_type n, const size_type local_rows, const size_type local_columns, const std::vector< size_type > &row_lengths, const bool is_symmetric=false, const std::vector< size_type > &offdiag_row_lengths=std::vector< size_type >())
This constructor is deprecated: please use the constructor with a sparsity pattern argument instead.
Member PETScWrappers::MPI::SparseMatrix::SparseMatrix (const MPI_Comm &communicator, const size_type m, const size_type n, const size_type local_rows, const size_type local_columns, const size_type n_nonzero_per_row, const bool is_symmetric=false, const size_type n_offdiag_nonzero_per_row=0)
This constructor is deprecated: please use the constructor with a sparsity pattern argument instead.
Member PETScWrappers::MPI::Vector::Vector (const MPI_Comm &communicator, const VectorBase &v, const size_type local_size)
The use of objects that are explicitly of type VectorBase is deprecated: use PETScWrappers::MPI::Vector instead.
Member PETScWrappers::PreconditionerBase
Use PETScWrappers::PreconditionBase instead.
Member PETScWrappers::VectorBase::is_non_negative () const
This function has been deprecated to improve compatibility with other classes inheriting from VectorSpaceVector.
Member PETScWrappers::VectorBase::local_size () const
use locally_owned_size() instead.
Member PETScWrappers::VectorBase::max () const
This function has been deprecated to improve compatibility with other classes inheriting from VectorSpaceVector. If you need to use this functionality then use the PETSc function VecMax instead.
Member PETScWrappers::VectorBase::min () const
This function has been deprecated to improve compatibility with other classes inheriting from VectorSpaceVector. If you need to use this functionality then use the PETSc function VecMin instead.
Member SparseBlockVanka< number >::SparseBlockVanka (const SparseMatrix< number > &M, const std::vector< bool > &selected, const unsigned int n_blocks, const BlockingStrategy blocking_strategy, const bool conserve_memory, const unsigned int n_threads=MultithreadInfo::n_threads())
This constructor is deprecated. The values passed to the last two arguments are ignored.
Member SparseVanka< number >::AdditionalData::AdditionalData (const std::vector< bool > &selected, const bool conserve_memory, const unsigned int n_threads=MultithreadInfo::n_threads())
The use of this constructor is deprecated - the second and third parameters are ignored.
Member SparseVanka< number >::SparseVanka (const SparseMatrix< number > &M, const std::vector< bool > &selected, const bool conserve_memory, const unsigned int n_threads=MultithreadInfo::n_threads())
The use of the last two parameters is deprecated. They are currently ignored.
Member SparsityTools::distribute_sparsity_pattern (BlockDynamicSparsityPattern &dsp, const std::vector< IndexSet > &owned_set_per_cpu, const MPI_Comm &mpi_comm, const IndexSet &myrange)
Use the distribute_sparsity_pattern() with a single index set for the present MPI process only.
Member SparsityTools::gather_sparsity_pattern (DynamicSparsityPattern &dsp, const std::vector< IndexSet > &owned_rows_per_processor, const MPI_Comm &mpi_comm, const IndexSet &ghost_range)
Use the gather_sparsity_pattern() method with the index set for the present processor only.
Member SUNDIALS::ARKode< VectorType >::reinit_vector
This function is no longer used and can be safely removed in user code.
Member SUNDIALS::KINSOL< VectorType >::solve_jacobian_system
Versions of SUNDIALS after 4.0 no longer provide all of the information necessary for this callback (see below). Use the solve_with_jacobian callback described below.
Class Threads::Thread< RT >
Use std::thread or std::jthread instead.
Class Threads::ThreadGroup< RT >
Use TaskGroup instead.
Member TimerOutput::enter_section (const std::string &section_name)
Use enter_subsection() instead.
Member TimerOutput::exit_section (const std::string &section_name="")
Use leave_subsection() instead.
Member TriaAccessor< 0, 1, spacedim >::number_of_children ()
Use n_active_descendants() instead.
Member TriaAccessor< 0, dim, spacedim >::number_of_children ()
Use n_active_descendants() instead.
Member TriaAccessor< structdim, dim, spacedim >::number_of_children () const
Use n_active_descendants() instead.
Member TrilinosWrappers::MPI::Vector::local_size () const
This function is deprecated.
Member Utilities::MPI::Partitioner::local_size () const
Use the more clearly named function locally_owned_size() instead.
Member VectorizedArray< Number, width >::n_array_elements
Use VectorizedArrayBase::size() instead.
Member VectorTools::integrate_difference (const Mapping< dim, spacedim > &mapping, const DoFHandler< dim, spacedim > &dof, const InVector &fe_function, const Function< spacedim, double > &exact_solution, OutVector &difference, const Quadrature< dim > &q, const NormType &norm, const Function< spacedim, double > *weight=nullptr, const double exponent=2.)
Use integrate_difference(const Mapping<dim, spacedim> &, const DoFHandler<dim, spacedim> &, const InVector &, const Function<spacedim, typename InVector::value_type> &, OutVector &, const Quadrature<dim> &, const NormType &, const Function<spacedim, double> *, const double) instead.
Member VectorTools::integrate_difference (const DoFHandler< dim, spacedim > &dof, const InVector &fe_function, const Function< spacedim, double > &exact_solution, OutVector &difference, const Quadrature< dim > &q, const NormType &norm, const Function< spacedim, double > *weight=nullptr, const double exponent=2.)
Use integrate_difference(const DoFHandler<dim, spacedim> &, const InVector &, const Function<spacedim, typename InVector::value_type> &exact_solution, OutVector &, const Quadrature<dim> &, const NormType &, const Function<spacedim, double> *, const double) instead.
Member VectorTools::integrate_difference (const hp::MappingCollection< dim, spacedim > &mapping, const DoFHandler< dim, spacedim > &dof, const InVector &fe_function, const Function< spacedim, double > &exact_solution, OutVector &difference, const hp::QCollection< dim > &q, const NormType &norm, const Function< spacedim, double > *weight=nullptr, const double exponent=2.)
Use integrate_difference(const hp::MappingCollection<dim, spacedim> &, const DoFHandler<dim, spacedim> &, const InVector &, const Function<spacedim, typename InVector::value_type> &, OutVector &, const hp::QCollection<dim> &, const NormType &, const Function<spacedim, double> *, const double) instead.
Member VectorTools::integrate_difference (const DoFHandler< dim, spacedim > &dof, const InVector &fe_function, const Function< spacedim, double > &exact_solution, OutVector &difference, const hp::QCollection< dim > &q, const NormType &norm, const Function< spacedim, double > *weight=nullptr, const double exponent=2.)
Use integrate_difference(const DoFHandler<dim, spacedim> &, const InVector &, const Function<spacedim, typename InVector::value_type> &, OutVector &, const hp::QCollection<dim> &, const NormType &, const Function<spacedim, double> *, const double) instead.
Member VectorTools::project_boundary_values_curl_conforming (const DoFHandler< dim, dim > &dof_handler, const unsigned int first_vector_component, const Function< dim, double > &boundary_function, const types::boundary_id boundary_component, AffineConstraints< double > &constraints, const Mapping< dim > &mapping)
Use the project_boundary_values_curl_conforming_l2() function instead of this one.
Member VectorTools::project_boundary_values_curl_conforming (const DoFHandler< dim, dim > &dof_handler, const unsigned int first_vector_component, const Function< dim, double > &boundary_function, const types::boundary_id boundary_component, AffineConstraints< double > &constraints, const hp::MappingCollection< dim, dim > &mapping_collection=hp::StaticMappingQ1< dim >::mapping_collection)
Use the project_boundary_values_curl_conforming_l2() function instead of this one.
Member XDMFEntry::get_xdmf_content (const unsigned int indent_level) const
Use the overload taking an unsigned int and a const ReferenceCell & instead.
Member ZeroFunction
use Functions::ZeroFunction instead.