Reference documentation for deal.II version 9.5.0
\(\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\}}\)
Loading...
Searching...
No Matches
Deprecated List
Member DataOutBase::default_suffix (const OutputFormat output_format)
Using Tecplot binary output is deprecated.
Member DataOutBase::VtkFlags::ZlibCompressionLevel
Use DataOutBase::CompressionLevel instead.
Member DoFHandler< dim, spacedim >::active_fe_index_type
Use types::fe_index instead.
Member DoFHandler< dim, spacedim >::get_active_fe_indices (std::vector< unsigned int > &active_fe_indices) const
Use get_active_fe_indices() that returns the result vector.
Member DoFHandler< dim, spacedim >::invalid_active_fe_index
Use numbers::invalid_fe_index instead.
Member DoFHandler< dim, spacedim >::invalid_fe_index
Use numbers::invalid_fe_index instead.
Member DoFHandler< dim, spacedim >::set_active_fe_indices (const std::vector< unsigned int > &active_fe_indices)
Use set_active_fe_indices() with the types::fe_index datatype.
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_locally_active_dofs (const DoFHandler< dim, spacedim > &dof_handler, IndexSet &dof_set)
Use the previous function instead.
Member DoFTools::extract_locally_active_level_dofs (const DoFHandler< dim, spacedim > &dof_handler, IndexSet &dof_set, const unsigned int level)
Use the previous function instead.
Member DoFTools::extract_locally_relevant_dofs (const DoFHandler< dim, spacedim > &dof_handler, IndexSet &dof_set)
Use the previous function instead.
Member DoFTools::extract_locally_relevant_level_dofs (const DoFHandler< dim, spacedim > &dof_handler, const unsigned int level, IndexSet &dof_set)
Use the previous function instead.
Member DoFTools::get_active_fe_indices (const DoFHandler< dim, spacedim > &dof_handler, std::vector< unsigned int > &active_fe_indices)
Use DoFHandler::get_active_fe_indices() that returns the result vector.
Member DoFTools::map_dofs_to_support_points (const hp::MappingCollection< dim, spacedim > &mapping, const DoFHandler< dim, spacedim > &dof_handler, std::map< types::global_dof_index, Point< spacedim > > &support_points, const ComponentMask &mask=ComponentMask())
Use the function that returns the std::map instead.
Member DoFTools::map_dofs_to_support_points (const Mapping< dim, spacedim > &mapping, const DoFHandler< dim, spacedim > &dof_handler, std::map< types::global_dof_index, Point< spacedim > > &support_points, const ComponentMask &mask=ComponentMask())
Use the function that returns the std::map instead.
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 >::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 >::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)
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, 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_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 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 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 >::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 FEInterfaceValues< dim, spacedim >::average (const unsigned int interface_dof_index, const unsigned int q_point, const unsigned int component=0) const
Use the average_of_shape_values() function instead.
Member FEInterfaceValues< dim, spacedim >::average_gradient (const unsigned int interface_dof_index, const unsigned int q_point, const unsigned int component=0) const
Use the average_of_shape_gradients() function instead.
Member FEInterfaceValues< dim, spacedim >::average_hessian (const unsigned int interface_dof_index, const unsigned int q_point, const unsigned int component=0) const
Use the average_of_shape_hessians() function instead.
Member FEInterfaceValues< dim, spacedim >::jump (const unsigned int interface_dof_index, const unsigned int q_point, const unsigned int component=0) const
Use the jump_in_shape_values() function instead.
Member FEInterfaceValues< dim, spacedim >::jump_3rd_derivative (const unsigned int interface_dof_index, const unsigned int q_point, const unsigned int component=0) const
Use the jump_in_shape_3rd_derivatives() function instead.
Member FEInterfaceValues< dim, spacedim >::jump_gradient (const unsigned int interface_dof_index, const unsigned int q_point, const unsigned int component=0) const
Use the jump_in_shape_gradients() function instead.
Member FEInterfaceValues< dim, spacedim >::jump_hessian (const unsigned int interface_dof_index, const unsigned int q_point, const unsigned int component=0) const
Use the jump_in_shape_hessians() function instead.
Member FEInterfaceViews::Scalar< dim, spacedim >::average (const unsigned int interface_dof_index, const unsigned int q_point) const
Use the average_of_values() function instead.
Member FEInterfaceViews::Scalar< dim, spacedim >::average_gradient (const unsigned int interface_dof_index, const unsigned int q_point) const
Use the average_of_gradients() function instead.
Member FEInterfaceViews::Scalar< dim, spacedim >::average_hessian (const unsigned int interface_dof_index, const unsigned int q_point) const
Use the average_of_hessians() function instead.
Member FEInterfaceViews::Scalar< dim, spacedim >::average_value (const unsigned int interface_dof_index, const unsigned int q_point) const
Use the average_of_values() function instead.
Member FEInterfaceViews::Scalar< dim, spacedim >::jump (const unsigned int interface_dof_index, const unsigned int q_point) const
Use the jump_in_values() function instead.
Member FEInterfaceViews::Scalar< dim, spacedim >::jump_3rd_derivative (const unsigned int interface_dof_index, const unsigned int q_point) const
Use the jump_in_third_derivatives() function instead.
Member FEInterfaceViews::Scalar< dim, spacedim >::jump_gradient (const unsigned int interface_dof_index, const unsigned int q_point) const
Use the jump_in_gradients() function instead.
Member FEInterfaceViews::Scalar< dim, spacedim >::jump_hessian (const unsigned int interface_dof_index, const unsigned int q_point) const
Use the jump_in_hessians() function instead.
Member FEInterfaceViews::Vector< dim, spacedim >::average (const unsigned int interface_dof_index, const unsigned int q_point) const
Use the average_of_values() function instead.
Member FEInterfaceViews::Vector< dim, spacedim >::average_gradient (const unsigned int interface_dof_index, const unsigned int q_point) const
Use the average_of_gradients() function instead.
Member FEInterfaceViews::Vector< dim, spacedim >::average_hessian (const unsigned int interface_dof_index, const unsigned int q_point) const
Use the average_of_hessians() function instead.
Member FEInterfaceViews::Vector< dim, spacedim >::jump (const unsigned int interface_dof_index, const unsigned int q_point) const
Use the jump_in_values() function instead.
Member FEInterfaceViews::Vector< dim, spacedim >::jump_3rd_derivative (const unsigned int interface_dof_index, const unsigned int q_point) const
Use the jump_in_third_derivatives() function instead.
Member FEInterfaceViews::Vector< dim, spacedim >::jump_gradient (const unsigned int interface_dof_index, const unsigned int q_point) const
Use the average_of_gradients() function instead.
Member FEInterfaceViews::Vector< dim, spacedim >::jump_hessian (const unsigned int interface_dof_index, const unsigned int q_point) const
Use the average_of_hessians() function instead.
Struct FEValuesViews::Scalar< dim, spacedim >::OutputType< Number >
Use the types defined in the surrounding class instead.
Struct FEValuesViews::SymmetricTensor< 2, dim, spacedim >::OutputType< Number >
Use the types defined in the surrounding class instead.
Struct FEValuesViews::Tensor< 2, dim, spacedim >::OutputType< Number >
Use the types defined in the surrounding class instead.
Struct 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.
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.
Struct GridTools::CellDataTransferBuffer< dim, T >
The implementation in deal.II has been rewritten, making this class obsolete for use within deal.II. Use your own data structures instead.
Member GridTools::rotate (const double angle, const unsigned int axis, Triangulation< dim, 3 > &triangulation)
Use the alternative with the unit vector instead.
Member identity
Use std_cxx20::identity_type instead.
Member LinearAlgebra::CUDAWrappers::Vector< Number >::import (const ReadWriteVector< Number > &V, VectorOperation::values operation, std::shared_ptr< const Utilities::MPI::CommunicationPatternBase > communication_pattern={}) override
Use import_elements() instead.
Member LinearAlgebra::distributed::BlockVector< Number >::import (const LinearAlgebra::ReadWriteVector< Number > &V, VectorOperation::values operation, std::shared_ptr< const Utilities::MPI::CommunicationPatternBase > communication_pattern={}) override
Use import_elements() instead.
Member LinearAlgebra::distributed::BlockVector< Number >::zero_out_ghosts () const
Use zero_out_ghost_values() instead.
Member LinearAlgebra::distributed::Vector< Number, MemorySpace >::import (const LinearAlgebra::ReadWriteVector< Number > &V, VectorOperation::values operation, std::shared_ptr< const Utilities::MPI::CommunicationPatternBase > communication_pattern={}) override
Use import_elements() instead.
Member LinearAlgebra::distributed::Vector< Number, MemorySpace >::import (const Vector< Number, MemorySpace2 > &src, VectorOperation::values operation)
Use import_elements() 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::EpetraWrappers::Vector::import (const ReadWriteVector< double > &V, VectorOperation::values operation, std::shared_ptr< const Utilities::MPI::CommunicationPatternBase > communication_pattern={}) override
Use import_elements() instead.
Member LinearAlgebra::ReadWriteVector< Number >::import (const CUDAWrappers::Vector< Number > &V, VectorOperation::values operation, const std::shared_ptr< const Utilities::MPI::CommunicationPatternBase > &communication_pattern={})
Use import_elements() instead.
Member LinearAlgebra::ReadWriteVector< Number >::import (const EpetraWrappers::Vector &V, VectorOperation::values operation, const std::shared_ptr< const Utilities::MPI::CommunicationPatternBase > &communication_pattern={})
Use import_elements() instead.
Member LinearAlgebra::ReadWriteVector< Number >::import (const TpetraWrappers::Vector< Number > &V, VectorOperation::values operation, const std::shared_ptr< const Utilities::MPI::CommunicationPatternBase > &communication_pattern={})
Use import_elements() instead.
Member LinearAlgebra::ReadWriteVector< Number >::import (const TrilinosWrappers::MPI::Vector &V, VectorOperation::values operation, const std::shared_ptr< const Utilities::MPI::CommunicationPatternBase > &communication_pattern={})
Use import_elements() instead.
Member LinearAlgebra::ReadWriteVector< Number >::import (const PETScWrappers::MPI::Vector &V, VectorOperation::values operation, const std::shared_ptr< const Utilities::MPI::CommunicationPatternBase > &communication_pattern={})
Use import_elements() instead.
Member LinearAlgebra::ReadWriteVector< Number >::import (const distributed::Vector< Number, MemorySpace > &V, VectorOperation::values operation, const std::shared_ptr< const Utilities::MPI::CommunicationPatternBase > &communication_pattern={})
Use import_elements() instead.
Member LinearAlgebra::ReadWriteVector< Number >::import (const LinearAlgebra::Vector< Number > &V, VectorOperation::values operation, const std::shared_ptr< const Utilities::MPI::CommunicationPatternBase > &communication_pattern={})
Use import_elements() instead.
Member LinearAlgebra::ReadWriteVector< Number >::import (const ::Vector< Number > &V, VectorOperation::values operation, const std::shared_ptr< const Utilities::MPI::CommunicationPatternBase > &communication_pattern={})
Use import_elements() instead.
Member LinearAlgebra::ReadWriteVector< Number >::n_elements () const
use locally_owned_size() instead.
Member LinearAlgebra::TpetraWrappers::Vector< Number >::import (const ReadWriteVector< Number > &V, VectorOperation::values operation, std::shared_ptr< const Utilities::MPI::CommunicationPatternBase > communication_pattern={}) override
Use import_elements() instead.
Member LinearAlgebra::Vector< Number >::import (const ReadWriteVector< Number > &V, VectorOperation::values operation, std::shared_ptr< const Utilities::MPI::CommunicationPatternBase > communication_pattern={}) override
Use import_elements() instead.
Member LinearAlgebra::VectorSpaceVector< Number >::import (const ReadWriteVector< Number > &V, VectorOperation::values operation, std::shared_ptr< const Utilities::MPI::CommunicationPatternBase > communication_pattern={})=0
Use import_elements() instead.
Member make_array_view (Tensor< rank, dim, Number > &tensor)
This function suggests that the elements of a Tensor object are stored as a contiguous array, but this is not in fact true and one should not pretend that this so. As a consequence, this function is deprecated.
Member make_array_view (const Tensor< rank, dim, Number > &tensor)
This function suggests that the elements of a Tensor object are stored as a contiguous array, but this is not in fact true and one should not pretend that this so. As a consequence, this function is deprecated.
Member make_array_view (const SymmetricTensor< rank, dim, Number > &tensor)
This function suggests that the elements of a SymmetricTensor object are stored as a contiguous array, but this is not in fact true and one should not pretend that this so. As a consequence, this function is deprecated.
Member make_array_view (SymmetricTensor< rank, dim, Number > &tensor)
This function suggests that the elements of a SymmetricTensor object are stored as a contiguous array, but this is not in fact true and one should not pretend that this so. As a consequence, this function is deprecated.
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.
Member MappingQCache< dim, spacedim >::initialize (const Triangulation< dim, spacedim > &triangulation, const MappingQ< dim, spacedim > &mapping)
Use initialize() version above instead.
Member parallel::distributed::Triangulation< dim, spacedim >::load (const std::string &filename, const bool autopartition) override
The autopartition parameter has been removed.
Member parallel::DistributedTriangulationBase< dim, spacedim >::load (const std::string &filename, const bool autopartition)=0
The autopartition parameter has been removed.
Member parallel::fullydistributed::Triangulation< dim, spacedim >::load (const std::string &filename, const bool autopartition) override
The autopartition parameter has been removed.
Member ParameterHandler::ShortText
Use ShortPRM instead of ShortText.
Member ParameterHandler::Text
Use PRM instead of Text.
Member Particles::ParticleAccessor< dim, spacedim >::get_surrounding_cell (const Triangulation< dim, spacedim > &triangulation) const
Deprecated version of the function with the same name above.
Member Particles::ParticleAccessor< dim, spacedim >::set_property_pool (PropertyPool< dim, spacedim > &property_pool)
This function is only kept for backward compatibility and has no meaning any more. ParticleAccessors always use the property pool of the owning particle handler.
Member Particles::ParticleHandler< dim, spacedim >::register_load_callback_function (const bool serialization)
Please use unpack_after_coarsening_and_refinement() or deserialize() instead. See there for further information about the purpose of this function.
Member Particles::ParticleHandler< dim, spacedim >::register_store_callback_function ()
Please use prepare_for_coarsening_and_refinement() or prepare_for_serialization() instead. See there for further information about the purpose of this function.
Member PETScWrappers::PreconditionerBase
Use PETScWrappers::PreconditionBase instead.
Member PETScWrappers::SolverBiCG::SolverBiCG (SolverControl &cn, const MPI_Comm mpi_communicator, const AdditionalData &data=AdditionalData())
Member PETScWrappers::SolverBicgstab::SolverBicgstab (SolverControl &cn, const MPI_Comm mpi_communicator, const AdditionalData &data=AdditionalData())
Member PETScWrappers::SolverCG::SolverCG (SolverControl &cn, const MPI_Comm mpi_communicator, const AdditionalData &data=AdditionalData())
Member PETScWrappers::SolverCGS::SolverCGS (SolverControl &cn, const MPI_Comm mpi_communicator, const AdditionalData &data=AdditionalData())
Member PETScWrappers::SolverChebychev::SolverChebychev (SolverControl &cn, const MPI_Comm mpi_communicator, const AdditionalData &data=AdditionalData())
Member PETScWrappers::SolverCR::SolverCR (SolverControl &cn, const MPI_Comm mpi_communicator, const AdditionalData &data=AdditionalData())
Member PETScWrappers::SolverGMRES::SolverGMRES (SolverControl &cn, const MPI_Comm mpi_communicator, const AdditionalData &data=AdditionalData())
Member PETScWrappers::SolverLSQR::SolverLSQR (SolverControl &cn, const MPI_Comm mpi_communicator, const AdditionalData &data=AdditionalData())
Member PETScWrappers::SolverPreOnly::SolverPreOnly (SolverControl &cn, const MPI_Comm mpi_communicator, const AdditionalData &data=AdditionalData())
Member PETScWrappers::SolverRichardson::SolverRichardson (SolverControl &cn, const MPI_Comm mpi_communicator, const AdditionalData &data=AdditionalData())
Member PETScWrappers::SolverTCQMR::SolverTCQMR (SolverControl &cn, const MPI_Comm mpi_communicator, const AdditionalData &data=AdditionalData())
Member PETScWrappers::SolverTFQMR::SolverTFQMR (SolverControl &cn, const MPI_Comm mpi_communicator, const AdditionalData &data=AdditionalData())
Member PETScWrappers::SparseDirectMUMPS::SparseDirectMUMPS (SolverControl &cn, const MPI_Comm mpi_communicator, const AdditionalData &data=AdditionalData())
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 Physics::Transformations::Rotations::rotation_matrix_3d (const Point< 3, Number > &axis, const Number &angle)
Use the variant with a Tensor as an axis.
Member ReferenceCell::compute_orientation (const std::array< T, N > &vertices_0, const std::array< T, N > &vertices_1) const
Use get_combined_orientation() instead.
Member ReferenceCell::permute_according_orientation (const std::array< T, N > &vertices, const unsigned int orientation) const
Use permute_by_combined_orientation() instead.
Class SLEPcWrappers::TransformationSpectrumFolding
Since deal.II requires PETSc 3.7 or newer this class no longer does anything.
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 SUNDIALS::IDA< VectorType >::solve_jacobian_system
Use solve_with_jacobian() instead which also uses a numerical tolerance.
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.
Member SymmetricTensor< rank_, dim, Number >::begin_raw ()
This function suggests that the elements of a SymmetricTensor object are stored as a contiguous array, but this is not in fact true and one should not pretend that this so. As a consequence, this function is deprecated.
Member SymmetricTensor< rank_, dim, Number >::begin_raw () const
This function suggests that the elements of a SymmetricTensor object are stored as a contiguous array, but this is not in fact true and one should not pretend that this so. As a consequence, this function is deprecated.
Member SymmetricTensor< rank_, dim, Number >::end_raw () const
This function suggests that the elements of a SymmetricTensor object are stored as a contiguous array, but this is not in fact true and one should not pretend that this so. As a consequence, this function is deprecated.
Member SymmetricTensor< rank_, dim, Number >::end_raw ()
This function suggests that the elements of a SymmetricTensor object are stored as a contiguous array, but this is not in fact true and one should not pretend that this so. As a consequence, this function is deprecated.
Member Tensor< 0, dim, Number >::begin_raw () const
This function suggests that the elements of a Tensor object are stored as a contiguous array, but this is not in fact true and one should not pretend that this so. As a consequence, this function is deprecated.
Member Tensor< 0, dim, Number >::begin_raw ()
This function suggests that the elements of a Tensor object are stored as a contiguous array, but this is not in fact true and one should not pretend that this so. As a consequence, this function is deprecated.
Member Tensor< 0, dim, Number >::end_raw () const
This function suggests that the elements of a Tensor object are stored as a contiguous array, but this is not in fact true and one should not pretend that this so. As a consequence, this function is deprecated.
Member Tensor< 0, dim, Number >::end_raw ()
This function suggests that the elements of a Tensor object are stored as a contiguous array, but this is not in fact true and one should not pretend that this so. As a consequence, this function is deprecated.
Member Tensor< rank_, dim, Number >::unroll (Vector< OtherNumber > &result) const
Use the more general function that takes a pair of iterators instead.
Member Threads::new_thread (RT(*fun_ptr)(Args...), std_cxx20::type_identity_t< Args >... args)
Use std::thread or std::jthread instead.
Member Threads::new_thread (FunctionObjectType function_object) -> Thread< decltype(function_object())>
Use std::thread or std::jthread instead.
Member Threads::new_thread (RT(C::*fun_ptr)(Args...), std_cxx20::type_identity_t< C > &c, std_cxx20::type_identity_t< Args >... args)
Use std::thread or std::jthread instead.
Member Threads::new_thread (RT(C::*fun_ptr)(Args...) const, std_cxx20::type_identity_t< const C > &c, std_cxx20::type_identity_t< Args >... args)
Use std::thread or std::jthread instead.
Member Threads::new_thread (const std::function< RT()> &function)
Use std::thread or std::jthread instead.
Class Threads::Thread< RT >
Use std::thread or std::jthread instead.
Class Threads::ThreadGroup< RT >
Use TaskGroup 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 Triangulation< dim, spacedim >::Signals::cell_weight
Use the weight signal instead which omits the base weight. You can invoke the old behavior by connecting a function to the signal that returns the base weight as follows. This function should be added in addition to the one that actually computes the weight.
Member TrilinosWrappers::MPI::Vector::import (const LinearAlgebra::ReadWriteVector< double > &rwv, const VectorOperation::values operation)
Use import_elements() instead.
Member TrilinosWrappers::MPI::Vector::local_size () const
This function is deprecated.
Member Utilities::MPI::ConsensusAlgorithms::Interface< RequestType, AnswerType >::Interface (Process< RequestType, AnswerType > &process, const MPI_Comm comm)
This constructor stores the Process object and the communicator so that one can later call the run() function without arguments. This approach is deprecated. Instead, use the default constructor of this class along with the run() function that takes an argument.
Member Utilities::MPI::ConsensusAlgorithms::Interface< RequestType, AnswerType >::run ()
This function is deprecated. It can be called if the Process object and communicator to be used have previously been provided to the non-default constructor. Use the run() functions taking arguments instead.
Member Utilities::MPI::ConsensusAlgorithms::NBX< RequestType, AnswerType >::NBX (Process< RequestType, AnswerType > &process, const MPI_Comm comm)
This constructor stores the Process object and the communicator so that one can later call the run() function without arguments. This approach is deprecated. Instead, use the default constructor of this class along with the run() function that takes an argument.
Member Utilities::MPI::ConsensusAlgorithms::PEX< RequestType, AnswerType >::PEX (Process< RequestType, AnswerType > &process, const MPI_Comm comm)
This constructor stores the Process object and the communicator so that one can later call the run() function without arguments. This approach is deprecated. Instead, use the default constructor of this class along with the run() function that takes an argument.
Member Utilities::MPI::ConsensusAlgorithms::Selector< RequestType, AnswerType >::Selector (Process< RequestType, AnswerType > &process, const MPI_Comm comm)
This constructor stores the Process object and the communicator so that one can later call the run() function without arguments. This approach is deprecated. Instead, use the default constructor of this class along with the run() function that takes an argument.
Member Utilities::MPI::ConsensusAlgorithms::Serial< RequestType, AnswerType >::Serial (Process< RequestType, AnswerType > &process, const MPI_Comm comm)
This constructor stores the Process object and the communicator so that one can later call the run() function without arguments. This approach is deprecated. Instead, use the default constructor of this class along with the run() function that takes an argument.
Member Utilities::MPI::create_group (const MPI_Comm comm, const MPI_Group &group, const int tag, MPI_Comm *new_comm)
Use MPI_Comm_create_group directly
Member Utilities::MPI::Partitioner::local_size () const
Use the more clearly named function locally_owned_size() instead.
Member XDMFEntry::get_xdmf_content (const unsigned int indent_level, const ReferenceCell &reference_cell) const
Use the other function instead.
Member XDMFEntry::XDMFEntry (const std::string &filename, const double time, const std::uint64_t nodes, const std::uint64_t cells, const unsigned int dim)
Use the constructor that additionally takes a ReferenceCell.
Member XDMFEntry::XDMFEntry (const std::string &mesh_filename, const std::string &solution_filename, const double time, const std::uint64_t nodes, const std::uint64_t cells, const unsigned int dim)
Use the constructor that additionally takes a ReferenceCell.
Member XDMFEntry::XDMFEntry (const std::string &mesh_filename, const std::string &solution_filename, const double time, const std::uint64_t nodes, const std::uint64_t cells, const unsigned int dim, const unsigned int spacedim)
Use the constructor that additionally takes a ReferenceCell.