Reference documentation for deal.II version 9.4.1
\(\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 CellId::to_cell (const Triangulation< dim, spacedim > &tria) const
Use Triangulation::create_cell_iterator() instead.
Member ConstantFunction
use Functions::ConstantFunction instead.
Member DataOut_DoFData< dim, patch_dim, spacedim, patch_spacedim >::merge_patches (const DataOut_DoFData< DoFHandlerType2::dimension, patch_dim, DoFHandlerType2::space_dimension, patch_spacedim > &source, const Point< patch_spacedim > &shift=Point< patch_spacedim >())
Use merge_patches() without the DoFHandlerType2 template 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 hp::FECollection< dim, spacedim > &fe)
Use reinit() and distribute_dofs() 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 >::set_fe (const FiniteElement< dim, spacedim > &fe)
Use distribute_dofs() instead.
Member DoFHandler< dim, spacedim >::set_fe (const hp::FECollection< 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::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_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 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.
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 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 hp::DoFHandler
The basic DoFHandler is capable of hp-adaptation now.
Member Legacy::DataOut
Use DataOut without the DoFHandlerType template instead.
Member Legacy::DataOut_DoFData
Use DataOut_DoFData without the DoFHandlerType template instead.
Member Legacy::DataOutFaces
Use DataOutFaces without the DoFHandlerType template instead.
Member Legacy::DataOutRotation
Use DataOutRotation without the DoFHandlerType template instead.
Member Legacy::Functions::FEFieldFunction
Use Functions::FEFieldFunction without the DoFHandlerType template instead.
Member Legacy::parallel::distributed::SolutionTransfer
Use parallel::distributed::SolutionTransfer without the DoFHandlerType template instead.
Member Legacy::SolutionTransfer
Use SolutionTransfer without the DoFHandlerType template instead.
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 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 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 (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 (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.
Class MappingFEField< dim, spacedim, VectorType, DoFHandlerType >
Use MappingFEField<dim, spacedim, VectorType> instead.
Member MappingQCache< dim, spacedim >::initialize (const Triangulation< dim, spacedim > &triangulation, const MappingQ< dim, spacedim > &mapping)
Use initialize() version above 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 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 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 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 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 parallel::distributed::BlockVector
Use LinearAlgebra::distributed::BlockVector 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 >::locally_relevant_ids () const
Use locally_owned_particle_ids() instead.
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::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 Physics::Transformations::Rotations::rotation_matrix_3d (const Point< 3, Number > &axis, const Number &angle)
Use the variant with a Tensor as an axis.
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 SUNDIALS::ARKode< VectorType >::reinit_vector
This function is no longer used and can be safely removed in user code.
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 ()
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 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 >::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 >::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< 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< rank_, dim, Number >::unroll (Vector< OtherNumber > &result) const
Use the more general function that takes a pair of iterators instead.
Member Threads::new_thread (const std::function< RT()> &function)
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(*fun_ptr)(Args...), typename identity< Args >::type... args)
Use std::thread or std::jthread instead.
Member Threads::new_thread (RT(C::*fun_ptr)(Args...), typename identity< C >::type &c, typename identity< Args >::type... args)
Use std::thread or std::jthread instead.
Member Threads::new_thread (RT(C::*fun_ptr)(Args...) const, typename identity< const C >::type &c, typename identity< Args >::type... args)
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::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
Use the overload taking an unsigned int and a const ReferenceCell & instead.
Member ZeroFunction
use Functions::ZeroFunction instead.