Reference documentation for deal.II version GIT relicensing-136-gb80d0be4af 2024-03-18 08:20:02+00:00
\(\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 AffineConstraints< number >::add_selected_constraints (const AffineConstraints &constraints_in, const IndexSet &filter)
This function is a combination of the get_view() function and merge() in that it selects a subset of constraints from another constraints object that is then merged into the current one. But the current function does not deal well with index sets. Furthermore, it simply discards parts of constraints that constrain one degree of freedom against ones that are not selected in the filter – something that should probably be considered a bug. Use get_view() and merge() instead.
Member AffineConstraints< number >::AffineConstraints (const IndexSet &locally_stored_constraints)
This constructor is equivalent to calling the following one with both of its arguments equal to the index set provided here. This is not wrong, but inefficient. Use the following constructor instead.
Member AffineConstraints< number >::reinit (const IndexSet &locally_stored_constraints)
Use the reinit() function with two index set arguments instead.
Member CELL_COARSEN
Use CellStatus::cell_will_be_coarsened instead
Member CELL_INVALID
Use CellStatus::cell_invalid instead
Member CELL_PERSIST
Use CellStatus::cell_will_persist instead
Member CELL_REFINE
Use CellStatus::cell_will_be_refined instead
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_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 Mapping< dim, spacedim > &mapping, const DoFHandler< dim, spacedim > &dof_handler, std::map< types::global_dof_index, Point< spacedim > > &support_points, const ComponentMask &mask={})
Use the function that returns the std::map instead.
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={})
Use the function that returns the std::map instead.
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 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_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.
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 GridTools::fix_up_distorted_child_cells (const typename Triangulation< dim, spacedim >::DistortedCellList &distorted_cells, Triangulation< dim, spacedim > &triangulation)
This function predates deal.II's use of manifolds and use of cell-local transfinite interpolation to place new points and is no longer necessary. See Manifolds::get_default_points_and_weights() for more information.
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={})
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={})
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 >::import (const LinearAlgebra::ReadWriteVector< Number > &V, VectorOperation::values operation, std::shared_ptr< const Utilities::MPI::CommunicationPatternBase > communication_pattern={})
Use import_elements() instead.
Member LinearAlgebra::EpetraWrappers::Vector::import (const ReadWriteVector< double > &V, const 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 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 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 ::Vector< Number > &V, VectorOperation::values operation, const std::shared_ptr< const Utilities::MPI::CommunicationPatternBase > &communication_pattern={})
Use import_elements() instead.
Member LinearAlgebra::TpetraWrappers::Vector< Number, MemorySpace >::import (const ReadWriteVector< Number > &V, VectorOperation::values operation, std::shared_ptr< const Utilities::MPI::CommunicationPatternBase > communication_pattern={})
Use import_elements() instead.
Member LinearAlgebra::TpetraWrappers::Vector< Number, MemorySpace >::import_elements (const ReadWriteVector< Number > &V, VectorOperation::values operation, const std::shared_ptr< const Utilities::MPI::CommunicationPatternBase > &communication_pattern)
Use Teuchos::RCP<> instead of std::shared_ptr<>.
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 (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 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 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 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::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 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 SolverGMRES< VectorType >::AdditionalData::max_n_tmp_vectors
Use max_basis_size instead.
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 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 >::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 >::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 () 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 Triangulation< dim, spacedim >::CELL_COARSEN
This is an alias for backward compatibility. Use CellStatus directly.
Member Triangulation< dim, spacedim >::CELL_INVALID
This is an alias for backward compatibility. Use CellStatus directly.
Member Triangulation< dim, spacedim >::CELL_PERSIST
This is an alias for backward compatibility. Use CellStatus directly.
Member Triangulation< dim, spacedim >::CELL_REFINE
This is an alias for backward compatibility. Use CellStatus directly.
Member Triangulation< dim, spacedim >::CellStatus
This is an alias for backward compatibility. Use CellStatus directly.
Member TrilinosWrappers::MPI::Vector::import (const LinearAlgebra::ReadWriteVector< double > &rwv, const VectorOperation::values operation)
Use import_elements() instead.
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::RemotePointEvaluation< dim, spacedim >::RemotePointEvaluation (const double tolerance, const bool enforce_unique_mapping=false, const unsigned int rtree_level=0, const std::function< std::vector< bool >()> &marked_vertices={})
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 &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.
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.