Reference documentation for deal.II version 8.5.1
Deprecated List
Class BlockDiagonalMatrix< MatrixType >
If deal.II was configured with C++11 support, use the LinearOperator class instead, see the module on linear operators for further details.
Member BlockSparseMatrixEZ< Number >::n_cols () const 1
Use n() instead.
Member BlockSparseMatrixEZ< Number >::n_rows () const 1
Use m() instead.
Member BlockVectorBase< VectorType >::supports_distributed_data
instead of using this variable, please use the type trait value is_serial_vector< VectorType >::value
Member contract
Use the contract() function that takes indices as template arguments and returns its result instead.
Member contract
Use the contract() function that takes indices as template arguments and returns its result instead.
Member contract
Use the contract() function that takes indices as template arguments and returns its result instead.
Member contract
Use operator* instead. It denotes a single contraction.
Member contract
Use operator* instead. It denotes a single contraction.
Member cross_product
Use the function cross_product_2d() that returns the value.
Member cross_product
Use the function cross_product_3d() that returns the value.
Member DataOutInterface< dim, spacedim >::write_pvd_record (std::ostream &out, const std::vector< std::pair< double, std::string > > &times_and_names) 1
Use DataOutBase::write_pvd_record() instead
Member DataOutInterface< dim, spacedim >::write_visit_record (std::ostream &out, const std::vector< std::string > &piece_names) 1
Use DataOutBase::write_visit_record() instead
Member DataOutInterface< dim, spacedim >::write_visit_record (std::ostream &out, const std::vector< std::vector< std::string > > &piece_names) 1
Use DataOutBase::write_visit_record() instead
Member DataOutInterface< dim, spacedim >::write_visit_record (std::ostream &out, const std::vector< std::pair< double, std::vector< std::string > > > &times_and_piece_names) 1
Use DataOutBase::write_visit_record() instead
Member DataPostprocessor< dim >::compute_derived_quantities_scalar (const std::vector< double > &solution_values, const std::vector< Tensor< 1, dim > > &solution_gradients, const std::vector< Tensor< 2, dim > > &solution_hessians, const std::vector< Point< dim > > &normals, const std::vector< Point< dim > > &evaluation_points, std::vector< Vector< double > > &computed_quantities) const 1
This function is deprecated. It has been superseded by the evaluate_scalar_field() function that receives a superset of the information provided to the current function through the members of the structure it receives as the first argument.
Member DataPostprocessor< dim >::compute_derived_quantities_vector (const std::vector< Vector< double > > &solution_values, const std::vector< std::vector< Tensor< 1, dim > > > &solution_gradients, const std::vector< std::vector< Tensor< 2, dim > > > &solution_hessians, const std::vector< Point< dim > > &normals, const std::vector< Point< dim > > &evaluation_points, std::vector< Vector< double > > &computed_quantities) const 1
This function is deprecated. It has been superseded by the evaluate_vector_field() function that receives a superset of the information provided to the current function through the members of the structure it receives as the first argument.
Member determinant
Do not use this function, evaluate the value manually.
Member determinant
Do not use this function, evaluate the value manually.
Member DoFCellAccessor< DoFHandlerType, level_dof_access >::get_dof_indices (std::vector< types::global_dof_index > &dof_indices) const
Currently, this function can also be called for non-active cells, if all degrees of freedom of the FiniteElement are located in vertices. This functionality will vanish in a future release.
Member DoFCellAccessor< DoFHandlerType, level_dof_access >::get_mg_dof_indices (std::vector< types::global_dof_index > &dof_indices) const
Use get_active_or_mg_dof_indices() with level_cell_iterator returned from begin_mg().
Member DoFHandler< dim, spacedim >::get_tria () const 1
Use get_triangulation() instead.
Member double_contract
Use the double_contract() function that takes indices as template arguments and returns its result instead.
Member double_contract
Use the double_contract() function that takes indices as template arguments and returns its result instead.
Member ExcInvalidTensorContractionIndex (int arg1)
Member FETools::compute_node_matrix (FullMatrix< double > &M, const FiniteElement< dim, spacedim > &fe) 1
Member FETools::get_fe_from_name (const std::string &parameter_name)
Use get_fe_by_name() with two template parameters instead
Member FETools::get_fe_from_name (const std::string &parameter_name)
Use get_fe_by_name() with two template parameters instead
Member FEValuesBase< dim, spacedim >::get_normal_vectors () const 1
Member FEValuesBase< dim, spacedim >::transform (std::vector< Tensor< 1, spacedim > > &transformed, const std::vector< Tensor< 1, dim > > &original, MappingType mapping) const 1
Use the various Mapping::transform() functions instead.
Member FiniteElement< dim, spacedim >::interpolate (std::vector< double > &local_dofs, const std::vector< double > &values) const 1
Use convert_generalized_support_point_values_to_nodal_values() instead.
Member FiniteElement< dim, spacedim >::interpolate (std::vector< double > &local_dofs, const std::vector< Vector< double > > &values, const unsigned int offset=0) const 1
Use convert_generalized_support_point_values_to_nodal_values() instead.
Member FiniteElement< dim, spacedim >::interpolate (std::vector< double > &local_dofs, const VectorSlice< const std::vector< std::vector< double > > > &values) const 1
Use convert_generalized_support_point_values_to_nodal_values() instead.
Member Functions::FEFieldFunction< dim, DoFHandlerType, VectorType >::ExcPointNotAvailableHere
Use VectorTools::ExcPointNotAvailableHere instead.
Member GridTools::get_face_connectivity_of_cells (const Triangulation< dim, spacedim > &triangulation, SparsityPattern &connectivity) 1
Member hp::DoFHandler< dim, spacedim >::get_tria () const 1
Use get_triangulation() instead.
Class InverseMatrixRichardson< VectorType >
If deal.II was configured with C++11 support, use the LinearOperator class instead, see the module on linear operators for further details.
Class IterativeInverse< VectorType >
If deal.II was configured with C++11 support, use the LinearOperator class instead, see the module on linear operators for further details.
Member LinearAlgebra::distributed::Vector< Number >::supports_distributed_data
instead of using this variable, please use the type trait value is_serial_vector< VectorType >::value
Member LocalIntegrators::Divergence::grad_div_matrix (FullMatrix< double > &M, const FEValuesBase< dim > &fe, const double factor=1.) 1
Use LocalIntegrators::GradDiv::cell_matrix() instead.
Member LocalIntegrators::Divergence::grad_div_residual (Vector< number > &result, const FEValuesBase< dim > &fetest, const VectorSlice< const std::vector< std::vector< Tensor< 1, dim > > > > &input, const double factor=1.) 1
Use LocalIntegrators::GradDiv::cell_residual() instead.
Member MappingQ1Eulerian< dim, VectorType, spacedim >::MappingQ1Eulerian (const VectorType &euler_vector, const DoFHandler< dim, spacedim > &euler_dof_handler) 1
Use the constructor with the reverse order of first and second argument.
Member MappingQEulerian< dim, VectorType, spacedim >::MappingQEulerian (const unsigned int degree, const VectorType &euler_vector, const DoFHandler< dim, spacedim > &euler_dof_handler) 1
Use the constructor with the reverse order of second and third argument.
Member MatrixFree< dim, Number >::AdditionalData::AdditionalData (const MPI_Comm mpi_communicator, const TasksParallelScheme tasks_parallel_scheme=partition_partition, const unsigned int tasks_block_size=0, const UpdateFlags mapping_update_flags=update_gradients|update_JxW_values, const unsigned int level_mg_handler=numbers::invalid_unsigned_int, const bool store_plain_indices=true, const bool initialize_indices=true, const bool initialize_mapping=true)
mpi_communicator should not be specified here since it is not used in the MatrixFree class.
Member MatrixFree< dim, Number >::AdditionalData::mpi_communicator
This variable is not used anymore. The mpi_communicator is automatically set to the one used by the triangulation.
Member MatrixFree< dim, Number >::reinit (const Mapping< dim > &mapping, const DoFHandlerType &dof_handler, const ConstraintMatrix &constraint, const IndexSet &locally_owned_dofs, const QuadratureType &quad, const AdditionalData additional_data=AdditionalData()) 1
Setting the index set specifically is not supported any more. Use the reinit function without index set argument to choose the one provided by DoFHandler::locally_owned_dofs().
Member MatrixFree< dim, Number >::reinit (const Mapping< dim > &mapping, const std::vector< const DoFHandlerType *> &dof_handler, const std::vector< const ConstraintMatrix *> &constraint, const std::vector< IndexSet > &locally_owned_set, const std::vector< QuadratureType > &quad, const AdditionalData additional_data=AdditionalData()) 1
Setting the index set specifically is not supported any more. Use the reinit function without index set argument to choose the one provided by DoFHandler::locally_owned_dofs().
Member MeshWorker::Assembler::ResidualSimple< VectorType >::initialize_local_blocks (const BlockIndices &)
This function is of no effect. Only the block info structure in DoFInfo is being used.
Class MGCoarseGridLACIteration< SolverType, VectorType >
Use MGCoarseGridIterativeSolver instead.
Member MGConstrainedDoFs::initialize (const DoFHandler< dim, spacedim > &dof, const typename FunctionMap< dim >::type &function_map, const ComponentMask &component_mask=ComponentMask()) 1
Use initialize() followed by make_zero_boundary_constraints() instead
Member MGLevelObject< Object >::clear () 1
Use clear_elements () instead
Member MGSmootherBlock< MatrixType, RelaxationType, number >::MGSmootherBlock (VectorMemory< BlockVector< number > > &mem, const unsigned int steps=1, const bool variable=false, const bool symmetric=false, const bool transpose=false, const bool reverse=false) 1
Since GrowingVectorMemory now uses a joint memory pool, it is recommended to use the constructor without the memory object.
Member MGTransferBlockBase::MGTransferBlockBase (const ConstraintMatrix &constraints, const MGConstrainedDoFs &mg_constrained_dofs) 1
constraints is unused.
Member MGTransferBlockSelect< number >::MGTransferBlockSelect (const ConstraintMatrix &constraints, const MGConstrainedDoFs &mg_constrained_dofs) 1
constraints is unused.
Member MGTransferPrebuilt< VectorType >::initialize_constraints (const ConstraintMatrix &constraints, const MGConstrainedDoFs &mg_constrained_dofs) 1
constraints is unused.
Member MGTransferPrebuilt< VectorType >::MGTransferPrebuilt (const ConstraintMatrix &constraints, const MGConstrainedDoFs &mg_constrained_dofs) 1
constraints is unused.
Member Multigrid< VectorType >::Multigrid (const DoFHandler< dim > &mg_dof_handler, const MGMatrixBase< VectorType > &matrix, const MGCoarseGridBase< VectorType > &coarse, const MGTransferBase< VectorType > &transfer, const MGSmootherBase< VectorType > &pre_smooth, const MGSmootherBase< VectorType > &post_smooth, const unsigned int minlevel=0, const unsigned int maxlevel=numbers::invalid_unsigned_int, Cycle cycle=v_cycle) 1
Use the other constructor instead. The DoFHandler is actually not needed.
Member MultipleParameterLoop::read_input (std::istream &input, const std::string &filename="input file", const std::string &last_line="") 1
This function has been deprecated in favor of the replacement MultipleParameterLoop::parse_input, which raises exceptions to indicate errors instead of returning an error code.
Member outer_product
Use the generic version that returns its result instead.
Member outer_product
Use operator* instead.
Member outer_product
Use operator* instead.
Member ParameterHandler::read_input (const std::string &filename, const bool optional=false, const bool write_stripped_file=false, const std::string &last_line="") 1
This function has been deprecated in favor of the replacement ParameterHandler::parse_input, which raises exceptions to indicate errors instead of returning an error code. ParameterHandler::parse_input does not have the capability to write default values to a file on failure: if you wish to duplicate that old behavior then you should catch the PathSearch::ExcFileNotFound exception and then call ParameterHandler::print_parameters.
Member ParameterHandler::read_input (std::istream &input, const std::string &filename="input file", const std::string &last_line="") 1
This function has been deprecated in favor of the replacement ParameterHandler::parse_input, which raises exceptions to indicate errors instead of returning an error code.
Member ParameterHandler::read_input_from_string (const char *s, const std::string &last_line="")
This function has been deprecated in favor of the replacement ParameterHandler::parse_input_from_string, which raises exceptions to indicate errors instead of returning an error code.
Member ParameterHandler::read_input_from_xml (std::istream &input) 1
This function has been deprecated in favor of the replacement ParameterHandler::parse_input_from_xml, which raises exceptions to indicate errors instead of returning an error code.
Member PETScWrappers::MatrixBase::add (const MatrixBase &other, const PetscScalar factor) 1
Use the function with order of arguments reversed instead.
Member PETScWrappers::MPI::Vector::supports_distributed_data
instead of using this variable, please use the type trait value is_serial_vector< VectorType >::value
Member PETScWrappers::MPI::Vector::Vector (const MPI_Comm &communicator, const VectorBase &v, const size_type local_size) 1
The use of objects that are explicitly of type VectorBase is deprecated: use PETScWrappers::MPI::Vector instead.
Member PETScWrappers::SolverBase::ExcPETScError (int arg1) 1
This function has been deprecated in favor of the more general LACExceptions::ExcPETScError exception class.
Member PETScWrappers::Vector::supports_distributed_data
instead of using this variable, please use the type trait value is_serial_vector< VectorType >::value
Member PETScWrappers::VectorBase::add (const VectorBase &V) 1
Use the operator += instead.
Member PointValueHistory< dim >::get_points (std::vector< std::vector< Point< dim > > > &locations)
Member PreconditionChebyshev< MatrixType, VectorType, PreconditionerType >::AdditionalData::matrix_diagonal_inverse
Set the variable preconditioner defined below instead.
Member PreconditionChebyshev< MatrixType, VectorType, PreconditionerType >::AdditionalData::nonzero_starting
For non-zero starting, use the step() and Tstep() interfaces, whereas vmult() provides the preconditioner interface.
Class ProductMatrix< VectorType >
If deal.II was configured with C++11 support, use the LinearOperator class instead, see the module on linear operators for further details.
Class ProductSparseMatrix< number, vector_number >
If deal.II was configured with C++11 support, use the LinearOperator class instead, see the module on linear operators for further details.
Class ScaledMatrix< VectorType >
If deal.II was configured with C++11 support, use the LinearOperator class instead, see the module on linear operators for further details.
Class ShiftedMatrix< MatrixType >
If deal.II was configured with C++11 support, use the LinearOperator class instead, see the module on linear operators for further details.
Class ShiftedMatrixGeneralized< MatrixType, MatrixType2, VectorType >
If deal.II was configured with C++11 support, use the LinearOperator class instead, see the module on linear operators for further details.
Class SolverCG< VectorType >
Alternatively these estimates can be written to deallog by setting flags in AdditionalData.
Member SolverCG< VectorType >::AdditionalData::AdditionalData (const bool log_coefficients, const bool compute_condition_number=false, const bool compute_all_condition_numbers=false, const bool compute_eigenvalues=false) 1
Instead use: connect_coefficients_slot, connect_condition_number_slot, and connect_eigenvalues_slot.
Member SolverGMRES< VectorType >::AdditionalData::AdditionalData (const unsigned int max_n_tmp_vectors, const bool right_preconditioning, const bool use_default_residual, const bool force_re_orthogonalization, const bool compute_eigenvalues) 1
To obtain the estimated eigenvalues instead use: connect_eigenvalues_slot
Member SparsityTools::reorder_Cuthill_McKee (const SparsityPattern &sparsity, std::vector< SparsityPattern::size_type > &new_indices, const std::vector< SparsityPattern::size_type > &starting_indices=std::vector< SparsityPattern::size_type >()) 1
Member SphericalManifold< dim, spacedim >::get_new_point (const ::Quadrature< spacedim > &quadrature) const 1
Use the other function that takes points and weights separately instead.
Class SwappableVector< number >
The usage of this class is deprecated.
Class TransposeMatrix< MatrixType, VectorType >
If deal.II was configured with C++11 support, use the LinearOperator class instead, see the module on linear operators for further details.
Member TrilinosWrappers::BlockSparseMatrix::domain_partitioner () const 1
Use the methods of the individual matrices based on IndexSet arguments.
Member TrilinosWrappers::BlockSparseMatrix::range_partitioner () const 1
Use the methods of the individual matrices based on IndexSet arguments.
Member TrilinosWrappers::BlockSparseMatrix::reinit (const std::vector< Epetra_Map > &input_maps, const ::BlockSparseMatrix< double > &deal_ii_sparse_matrix, const double drop_tolerance=1e-13) 1
Use the respective method with IndexSet arguments instead.
Member TrilinosWrappers::BlockSparsityPattern::BlockSparsityPattern (const std::vector< Epetra_Map > &parallel_partitioning) 1
Use the respective method with IndexSet arguments instead.
Member TrilinosWrappers::BlockSparsityPattern::reinit (const std::vector< Epetra_Map > &parallel_partitioning) 1
Use the respective method with IndexSet arguments instead.
Member TrilinosWrappers::MPI::Vector::supports_distributed_data
instead of using this variable, please use the type trait value is_serial_vector< VectorType >::value
Member TrilinosWrappers::SparseMatrix::col_partitioner () const 1
Usually not necessary. If desired, access it via the Epetra_CrsMatrix.
Member TrilinosWrappers::SparseMatrix::domain_partitioner () const 1
Use locally_owned_domain_indices() instead.
Member TrilinosWrappers::SparseMatrix::range_partitioner () const 1
Use locally_owned_range_indices() instead.
Member TrilinosWrappers::SparseMatrix::reinit (const Epetra_Map &parallel_partitioning, const SparsityPatternType &sparsity_pattern, const bool exchange_data=false) 1
Use the respective method with IndexSet argument instead.
Member TrilinosWrappers::SparseMatrix::reinit (const Epetra_Map &row_parallel_partitioning, const Epetra_Map &col_parallel_partitioning, const ::SparseMatrix< number > &dealii_sparse_matrix, const double drop_tolerance=1e-13, const bool copy_values=true, const SparsityPattern *use_this_sparsity=0) 1
Use the respective method with IndexSet argument instead.
Member TrilinosWrappers::SparseMatrix::reinit (const Epetra_Map &row_parallel_partitioning, const Epetra_Map &col_parallel_partitioning, const SparsityPatternType &sparsity_pattern, const bool exchange_data=false) 1
Use the respective method with IndexSet argument instead.
Member TrilinosWrappers::SparseMatrix::reinit (const Epetra_Map &parallel_partitioning, const ::SparseMatrix< number > &dealii_sparse_matrix, const double drop_tolerance=1e-13, const bool copy_values=true, const SparsityPattern *use_this_sparsity=0) 1
Use the respective method with IndexSet argument instead.
Member TrilinosWrappers::SparseMatrix::row_partitioner () const 1
Use locally_owned_range_indices() instead.
Member TrilinosWrappers::SparseMatrix::SparseMatrix (const Epetra_Map &parallel_partitioning, const size_type n_max_entries_per_row=0) 1
Use the respective method with IndexSet argument instead.
Member TrilinosWrappers::SparseMatrix::SparseMatrix (const Epetra_Map &row_parallel_partitioning, const Epetra_Map &col_parallel_partitioning, const size_type n_max_entries_per_row=0) 1
Use the respective method with IndexSet argument instead.
Member TrilinosWrappers::SparseMatrix::SparseMatrix (const Epetra_Map &row_parallel_partitioning, const Epetra_Map &col_parallel_partitioning, const std::vector< unsigned int > &n_entries_per_row) 1
Use the respective method with IndexSet argument instead.
Member TrilinosWrappers::SparseMatrix::SparseMatrix (const Epetra_Map &parallel_partitioning, const std::vector< unsigned int > &n_entries_per_row) 1
Use the respective method with IndexSet argument instead.
Member TrilinosWrappers::SparsityPattern::col_partitioner () const 1
Usually not necessary. If desired, access via the Epetra_FECrsGraph.
Member TrilinosWrappers::SparsityPattern::domain_partitioner () const 1
Use locally_owned_domain_indices() instead.
Member TrilinosWrappers::SparsityPattern::range_partitioner () const 1
Use locally_owned_range_indices() instead.
Member TrilinosWrappers::SparsityPattern::reinit (const Epetra_Map &parallel_partitioning, const size_type n_entries_per_row=0) 1
Use the respective method with IndexSet argument instead.
Member TrilinosWrappers::SparsityPattern::reinit (const Epetra_Map &row_parallel_partitioning, const Epetra_Map &col_parallel_partitioning, const size_type n_entries_per_row=0) 1
Use the respective method with IndexSet argument instead.
Member TrilinosWrappers::SparsityPattern::reinit (const Epetra_Map &row_parallel_partitioning, const Epetra_Map &col_parallel_partitioning, const std::vector< size_type > &n_entries_per_row) 1
Use the respective method with IndexSet argument instead.
Member TrilinosWrappers::SparsityPattern::reinit (const Epetra_Map &row_parallel_partitioning, const Epetra_Map &col_parallel_partitioning, const SparsityPatternType &nontrilinos_sparsity_pattern, const bool exchange_data=false) 1
Use the respective method with IndexSet argument instead.
Member TrilinosWrappers::SparsityPattern::reinit (const Epetra_Map &parallel_partitioning, const SparsityPatternType &nontrilinos_sparsity_pattern, const bool exchange_data=false) 1
Use the respective method with IndexSet argument instead.
Member TrilinosWrappers::SparsityPattern::reinit (const Epetra_Map &parallel_partitioning, const std::vector< size_type > &n_entries_per_row) 1
Use the respective method with IndexSet argument instead.
Member TrilinosWrappers::SparsityPattern::row_partitioner () const 1
Use locally_owned_range_indices() instead.
Member TrilinosWrappers::SparsityPattern::SparsityPattern (const Epetra_Map &row_parallel_partitioning, const Epetra_Map &col_parallel_partitioning, const size_type n_entries_per_row=0) 1
Use the respective method with IndexSet argument instead.
Member TrilinosWrappers::SparsityPattern::SparsityPattern (const Epetra_Map &parallel_partitioning, const size_type n_entries_per_row=0) 1
Use the respective method with IndexSet argument instead.
Member TrilinosWrappers::SparsityPattern::SparsityPattern (const Epetra_Map &parallel_partitioning, const std::vector< size_type > &n_entries_per_row) 1
Use the respective method with IndexSet argument instead.
Member TrilinosWrappers::SparsityPattern::SparsityPattern (const Epetra_Map &row_parallel_partitioning, const Epetra_Map &col_parallel_partitioning, const std::vector< size_type > &n_entries_per_row) 1
Use the respective method with IndexSet argument instead.
Member TrilinosWrappers::SparsityPattern::trilinos_communicator () const 1
Use get_mpi_communicator instead.
Member TrilinosWrappers::Vector::supports_distributed_data
instead of using this variable, please use the type trait value is_serial_vector< VectorType >::value
Member update_cell_normal_vectors
Use update_normal_vectors instead.
Member update_face_normal_vectors
Use update_normal_vectors instead.
Member update_q_points
Use update_quadrature_points instead.
Member update_second_derivatives
Use update_hessians instead.
Member Utilities::System::job_supports_mpi () 1
Use Utilities::MPI::job_supports_mpi() instead.
Member Vector< Number >::add (const Vector< Number > &V) 1
Use the operator += instead.
Member Vector< Number >::supports_distributed_data
instead of using this variable, please use the type trait value is_serial_vector< VectorType >::value