Reference documentation for deal.II version 8.1.0
Deprecated List
Class BlockList
This class is experimental and will be removed in a future release.
Member BlockList::cell_generates_vertex_patch (const ITERATOR cell, bool same_level_only) const DEAL_II_DEPRECATED
This function will move to DoFTools.
Member BlockList::count_vertex_patches (const ITERATOR begin, const typename identity< ITERATOR >::type end, bool same_level_only) const DEAL_II_DEPRECATED
This function will move to DoFTools.
Member BlockList::initialize (size_type n_blocks, const ITERATOR begin, const typename identity< ITERATOR >::type end, const std::vector< bool > &selected_dofs, size_type offset=0) DEAL_II_DEPRECATED
This function will move to DoFTools.
Member BlockList::initialize_mg (size_type n_blocks, const ITERATOR begin, const typename identity< ITERATOR >::type end) DEAL_II_DEPRECATED
This function will move to DoFTools.
Member BlockList::initialize_mg (size_type n_blocks, const ITERATOR begin, const typename identity< ITERATOR >::type end, const std::vector< bool > &selected_dofs, size_type offset=0) DEAL_II_DEPRECATED
This function will move to DoFTools.
Member BlockList::initialize_vertex_patches_mg (size_type n_blocks, const ITERATOR begin, const typename identity< ITERATOR >::type end, const std::vector< bool > &selected_dofs=std::vector< bool >(), size_type offset=0) DEAL_II_DEPRECATED
This function will move to DoFTools.
Member BlockMatrixArray< number >::BlockMatrixArray (const unsigned int n_block_rows, const unsigned int n_block_cols, VectorMemory< Vector< number > > &mem) DEAL_II_DEPRECATED
The last argument is ignored. Use the constructor with only the first two arguments.
Member BlockMatrixArray< number >::enter_aux (VectorMemory< Vector< number > > &mem, const MATRIX &matrix, const unsigned int row, const unsigned int col, const double prefix=1., const bool transpose=false) DEAL_II_DEPRECATED
The first argument is ignored. Use the function with same name but without the first argument.
Member BlockMatrixArray< number >::initialize (const unsigned int n_block_rows, const unsigned int n_block_cols, VectorMemory< Vector< number > > &mem) DEAL_II_DEPRECATED
The last argument is ignored. Use the function with same name but only the first two arguments.
Member BlockMatrixBase< MatrixType >::compress () DEAL_II_DEPRECATED
: use compress() with VectorOperation instead.
Member BlockTrianglePrecondition< number >::BlockTrianglePrecondition (const unsigned int n_block_rows, VectorMemory< Vector< number > > &mem, const bool backward=false) DEAL_II_DEPRECATED
The second argument is ignored. Use the constructor with only the first and third argument.
Member BlockTrianglePrecondition< number >::enter_aux (VectorMemory< Vector< double > > &mem, const MATRIX &matrix, const size_type row, const size_type col, const double prefix=1., const bool transpose=false) DEAL_II_DEPRECATED
The first argument is ignored. Use enter() instead.
Member BlockTrianglePrecondition< number >::initialize (const unsigned int n_block_rows, VectorMemory< Vector< number > > &mem, const bool backward=false) DEAL_II_DEPRECATED
The second argument is ignored. Use the function without that argument.
Member BlockVector< Number >::scale (const value_type factor) DEAL_II_DEPRECATED
Use operator*= instead.
Member BlockVectorBase< VectorType >::compress () DEAL_II_DEPRECATED
: use compress(VectorOperation::values) instead.
Member ChunkSparsityPattern::ChunkSparsityPattern (const size_type m, const size_type n, const size_type max_chunks_per_row, const size_type chunk_size, const bool optimize_diagonal) DEAL_II_DEPRECATED
This constructor is deprecated. Use the version without the last argument
Member ChunkSparsityPattern::ChunkSparsityPattern (const size_type m, const size_type n, const std::vector< size_type > &row_lengths, const size_type chunk_size, const bool optimize_diagonal) DEAL_II_DEPRECATED
This constructor is deprecated. Use the version without the last argument
Member ChunkSparsityPattern::ChunkSparsityPattern (const size_type m, const std::vector< size_type > &row_lengths, const size_type chunk_size, const bool optimize_diagonal) DEAL_II_DEPRECATED
This constructor is deprecated. Use the version without the last argument
Member ChunkSparsityPattern::copy_from (const size_type n_rows, const size_type n_cols, const ForwardIterator begin, const ForwardIterator end, const size_type chunk_size, const bool optimize_diagonal) DEAL_II_DEPRECATED
This function is deprecated. Use the function without the last argument
Member ChunkSparsityPattern::copy_from (const SparsityType &csp, const size_type chunk_size, const bool optimize_diagonal) DEAL_II_DEPRECATED
This function is deprecated. Use the function without the last argument
Member ChunkSparsityPattern::copy_from (const FullMatrix< number > &matrix, const size_type chunk_size, const bool optimize_diagonal) DEAL_II_DEPRECATED
This function is deprecated. Use the function without the last argument
Member ChunkSparsityPattern::optimize_diagonal () const DEAL_II_DEPRECATED
The function always returns true if the matrix is square and false if it is not.
Member ChunkSparsityPattern::reinit (const size_type m, const size_type n, const size_type max_per_row, const size_type chunk_size, const bool optimize_diagonal) DEAL_II_DEPRECATED
This function is deprecated. Use the function without the last argument
Member ChunkSparsityPattern::reinit (const size_type m, const size_type n, const std::vector< size_type > &row_lengths, const size_type chunk_size, const bool optimize_diagonal) DEAL_II_DEPRECATED
This function is deprecated. Use the function without the last argument
Member ChunkSparsityPattern::reinit (const size_type m, const size_type n, const VectorSlice< const std::vector< size_type > > &row_lengths, const size_type chunk_size, const bool optimize_diagonal) DEAL_II_DEPRECATED
This function is deprecated. Use the function without the last argument
Member ConstraintMatrix::condense (const SparseMatrix< number > &uncondensed, SparseMatrix< number > &condensed) const DEAL_II_DEPRECATED
The functions converting an uncondensed matrix into its condensed form are deprecated. Use the functions doing the in-place condensation leaving the size of the linear system unchanged.
Member ConstraintMatrix::condense (const VectorType &uncondensed, VectorType &condensed) const DEAL_II_DEPRECATED
The functions converting an uncondensed matrix into its condensed form are deprecated. Use the functions doing the in-place condensation leaving the size of the linear system unchanged.
Member ConstraintMatrix::condense (const SparseMatrix< number > &uncondensed_matrix, const VectorType &uncondensed_vector, SparseMatrix< number > &condensed_matrix, VectorType &condensed_vector) const DEAL_II_DEPRECATED
The functions converting an uncondensed matrix into its condensed form are deprecated. Use the functions doing the in-place condensation leaving the size of the linear system unchanged.
Member DataOutInterface< dim, spacedim >::create_xdmf_entry (const std::string &h5_filename, const double cur_time, MPI_Comm comm) const DEAL_II_DEPRECATED
: use create_xdmf_entry(DataOutFilter, ...) instead
Member DataOutInterface< dim, spacedim >::write_hdf5_parallel (const std::string &filename, MPI_Comm comm) const DEAL_II_DEPRECATED
: use write_hdf5_parallel(DataOutFilter, ...) instead
Member DataPostprocessor< dim >::compute_derived_quantities_scalar (const std::vector< double > &uh, const std::vector< Tensor< 1, dim > > &duh, const std::vector< Tensor< 2, dim > > &dduh, const std::vector< Point< dim > > &normals, std::vector< Vector< double > > &computed_quantities) const DEAL_II_DEPRECATED
Member DataPostprocessor< dim >::compute_derived_quantities_vector (const std::vector< Vector< double > > &uh, const std::vector< std::vector< Tensor< 1, dim > > > &duh, const std::vector< std::vector< Tensor< 2, dim > > > &dduh, const std::vector< Point< dim > > &normals, std::vector< Vector< double > > &computed_quantities) const DEAL_II_DEPRECATED
Member DEAL_II_DEPRECATED
Member DoFCellAccessor< DH, 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< DH, 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 DoFRenumbering::downstream_dg (DH &dof, unsigned int level, const Point< DH::space_dimension > &direction) DEAL_II_DEPRECATED
Use downstream() instead.
Member DoFRenumbering::downstream_dg (DH &dof, const Point< DH::space_dimension > &direction) DEAL_II_DEPRECATED
Use downstream() instead.
Member DoFTools::count_dofs_per_component (const DoFHandler< dim, spacedim > &dof_handler, std::vector< types::global_dof_index > &dofs_per_component, std::vector< unsigned int > target_component) DEAL_II_DEPRECATED
See the previous function with the same name for a description. This function exists for compatibility with older versions only.
Member DoFTools::make_sparsity_pattern (const DH &dof, const std::vector< std::vector< bool > > &mask, SparsityPattern &sparsity_pattern) DEAL_II_DEPRECATED
This is the old form of the previous function. It generates a table of DoFTools::Coupling values (where a true value in the mask is translated into a Coupling::always value in the table) and calls the function above.
Member FEValuesBase< dim, spacedim >::cell_normal_vector (const unsigned int i) const DEAL_II_DEPRECATED
Use normal_vector() instead.
Member FEValuesBase< dim, spacedim >::get_cell_normal_vectors () const DEAL_II_DEPRECATED
Use get_normal_vectors() instead.
Member FEValuesBase< dim, spacedim >::get_function_2nd_derivatives (const InputVector &, std::vector< Tensor< 2, spacedim > > &) const DEAL_II_DEPRECATED
Wrapper for get_function_hessians()
Member FEValuesBase< dim, spacedim >::get_function_2nd_derivatives (const InputVector &, std::vector< std::vector< Tensor< 2, spacedim > > > &, bool=false) const DEAL_II_DEPRECATED
Wrapper for get_function_hessians()
Member FEValuesBase< dim, spacedim >::get_function_grads (const InputVector &fe_function, std::vector< Tensor< 1, spacedim > > &gradients) const DEAL_II_DEPRECATED
Use get_function_gradients() instead.
Member FEValuesBase< dim, spacedim >::get_function_grads (const InputVector &fe_function, std::vector< std::vector< Tensor< 1, spacedim > > > &gradients) const DEAL_II_DEPRECATED
Use get_function_gradients() instead.
Member FEValuesBase< dim, spacedim >::get_function_grads (const InputVector &fe_function, const VectorSlice< const std::vector< types::global_dof_index > > &indices, std::vector< Tensor< 1, spacedim > > &gradients) const DEAL_II_DEPRECATED
Use get_function_gradients() instead.
Member FEValuesBase< dim, spacedim >::get_function_grads (const InputVector &fe_function, const VectorSlice< const std::vector< types::global_dof_index > > &indices, std::vector< std::vector< Tensor< 1, spacedim > > > &gradients, bool quadrature_points_fastest=false) const DEAL_II_DEPRECATED
Use get_function_gradients() instead.
Member FEValuesBase< dim, spacedim >::shape_2nd_derivative (const unsigned int function_no, const unsigned int point_no) const DEAL_II_DEPRECATED
Wrapper for shape_hessian()
Member FEValuesBase< dim, spacedim >::shape_2nd_derivative_component (const unsigned int function_no, const unsigned int point_no, const unsigned int component) const DEAL_II_DEPRECATED
Wrapper for shape_hessian_component()
Member GridGenerator::laplace_transformation (Triangulation< dim > &tria, const std::map< unsigned int, Point< dim > > &new_points) DEAL_II_DEPRECATED
This function has been moved to GridTools::laplace_transform
Member GridGenerator::parallelogram (Triangulation< dim > &tria, const Tensor< 2, dim > &corners, const bool colorize=false) DEAL_II_DEPRECATED
Use the other function of same name.
Member GridOutFlags::XFig::DEAL_II_DEPRECATED
Use the color_by enum instead.
Member Mapping< dim, spacedim >::transform_contravariant (const VectorSlice< const std::vector< Tensor< 1, dim > > > input, const unsigned int offset, VectorSlice< std::vector< Tensor< 1, spacedim > > > output, const typename Mapping< dim, spacedim >::InternalDataBase &internal) const DEAL_II_DEPRECATED
Use transform() instead.
Member Mapping< dim, spacedim >::transform_contravariant (const VectorSlice< const std::vector< DerivativeForm< 1, dim, spacedim > > > input, const unsigned int offset, const VectorSlice< std::vector< Tensor< 2, spacedim > > > output, const typename Mapping< dim, spacedim >::InternalDataBase &internal) const DEAL_II_DEPRECATED
Use transform() instead.
Member Mapping< dim, spacedim >::transform_covariant (const VectorSlice< const std::vector< Tensor< 1, dim > > > input, const unsigned int offset, VectorSlice< std::vector< Tensor< 1, spacedim > > > output, const InternalDataBase &internal) const DEAL_II_DEPRECATED
Use transform() instead.
Member Mapping< dim, spacedim >::transform_covariant (const VectorSlice< const std::vector< DerivativeForm< 1, dim, spacedim > > > input, const unsigned int offset, VectorSlice< std::vector< Tensor< 2, spacedim > > > output, const InternalDataBase &internal) const DEAL_II_DEPRECATED
Use transform() instead.
Member MeshWorker::Assembler::MatrixSimple< MATRIX >::initialize_local_blocks (const BlockIndices &)
This function is of no effect. Only the block info structure in DoFInfo is being used.
Member MeshWorker::Assembler::MGMatrixSimple< MATRIX >::initialize_local_blocks (const BlockIndices &)
This function is of no effect. Only the block info structure in DoFInfo is being used.
Member MeshWorker::Assembler::ResidualSimple< VECTOR >::initialize_local_blocks (const BlockIndices &)
This function is of no effect. Only the block info structure in DoFInfo is being used.
Member MeshWorker::integration_loop (ITERATOR begin, typename identity< ITERATOR >::type end, DoFInfo< dim, spacedim > &dof_info, IntegrationInfoBox< dim, spacedim > &box, const std_cxx1x::function< void(DoFInfo< dim > &, IntegrationInfo< dim, spacedim > &)> &cell_worker, const std_cxx1x::function< void(DoFInfo< dim > &, IntegrationInfo< dim, spacedim > &)> &boundary_worker, const std_cxx1x::function< void(DoFInfo< dim > &, DoFInfo< dim > &, IntegrationInfo< dim, spacedim > &, IntegrationInfo< dim, spacedim > &)> &face_worker, ASSEMBLER &assembler, bool cells_first=true) DEAL_II_DEPRECATED
The simplification in this loop is insignificant. Therefore, it is recommended to use loop() instead.
Class MGDoFHandler< dim, spacedim >
All functionality of this class has been moved to DoFHandler. Thus, this class is only a wrapper left in the library for compatibility reasons.
Member MGLevelObject< Object >::get_maxlevel () const DEAL_II_DEPRECATED
Replaced by max_level()
Member MGLevelObject< Object >::get_minlevel () const DEAL_II_DEPRECATED
Replaced by min_level()
Class MGMatrix< MATRIX, VECTOR >
Use the much simpler class mg::Matrix instead.
Member MGSmoother< VECTOR >::MGSmoother (VectorMemory< VECTOR > &mem, const unsigned int steps=1, const bool variable=false, const bool symmetric=false, const bool transpose=false) DEAL_II_DEPRECATED
Since GrowingVectorMemory now uses a joint memory pool, it is recommended to use the constructor without the memory object.
Member MGSmootherPrecondition< MATRIX, PRECONDITIONER, VECTOR >::MGSmootherPrecondition (VectorMemory< VECTOR > &mem, const unsigned int steps=1, const bool variable=false, const bool symmetric=false, const bool transpose=false) DEAL_II_DEPRECATED
Use the constructor without the vector memory object
Member MGSmootherRelaxation< MATRIX, RELAX, VECTOR >::MGSmootherRelaxation (VectorMemory< VECTOR > &mem, const unsigned int steps=1, const bool variable=false, const bool symmetric=false, const bool transpose=false) DEAL_II_DEPRECATED
Use the constructor without the vector memory object
Member MGTools::apply_boundary_values (const std::set< types::global_dof_index > &boundary_dofs, SparseMatrix< number > &matrix, const bool preserve_symmetry, const bool ignore_zeros=false) DEAL_II_DEPRECATED
Member MGTools::apply_boundary_values (const std::set< types::global_dof_index > &boundary_dofs, BlockSparseMatrix< number > &matrix, const bool preserve_symmetry) DEAL_II_DEPRECATED
Member MGTools::count_dofs_per_component (const DoFHandler< dim, spacedim > &mg_dof, std::vector< std::vector< types::global_dof_index > > &result, std::vector< unsigned int > target_component) DEAL_II_DEPRECATED
Wrapper for the other function with same name, introduced for compatibility.
Member Multigrid< VECTOR >::Tvmult (VECTOR &dst, const VECTOR &src) const DEAL_II_DEPRECATED
Even worse than vmult(), this function is not even implemented, but just declared such that certain objects relying on it can be constructed.
Member Multigrid< VECTOR >::Tvmult_add (VECTOR &dst, const VECTOR &src) const DEAL_II_DEPRECATED
Even worse than vmult(), this function is not even implemented, but just declared such that certain objects relying on it can be constructed.
Member Multigrid< VECTOR >::vmult (VECTOR &dst, const VECTOR &src) const DEAL_II_DEPRECATED
This function is purely experimental and will probably never be implemented in a way that it can be released.
Member Multigrid< VECTOR >::vmult_add (VECTOR &dst, const VECTOR &src) const DEAL_II_DEPRECATED
This function is purely experimental and will probably never be implemented in a way that it can be released.
Member MultithreadInfo::DEAL_II_DEPRECATED
: use set_thread_limit() instead.
Member parallel::distributed::BlockVector< Number >::scale (const value_type factor) DEAL_II_DEPRECATED
Use operator*= instead.
Member parallel::distributed::Vector< Number >::compress () DEAL_II_DEPRECATED
: use compress(VectorOperation::values) instead.
Member parallel::distributed::Vector< Number >::compress_finish (const bool add_ghost_data=true) DEAL_II_DEPRECATED
: use compress_finish(VectorOperation::values) instead.
Member parallel::distributed::Vector< Number >::scale (const Number factor) DEAL_II_DEPRECATED
This function is deprecated and will be removed in a future version. Use operator *= and operator /= instead.
Member PETScWrappers::MatrixBase::compress () DEAL_II_DEPRECATED
: use compress() with VectorOperation instead.
Member PETScWrappers::VectorBase::compress () DEAL_II_DEPRECATED
: use compress(VectorOperation::values) instead.
Member PETScWrappers::VectorBase::update_ghost_values () const DEAL_II_DEPRECATED
: calling this method is no longer necessary.
Member PointValueHistory< dim >::mark_locations () DEAL_II_DEPRECATED
Member PreconditionBlock< MATRIX, inverse_type >::n_blocks () const DEAL_II_DEPRECATED
Use size() instead.
Class PreconditionedMatrix< MATRIX, PRECOND, VECTOR >
Use ProductMatrix instead.
Class PreconditionLACSolver< SOLVER, MATRIX, PRECONDITION >
This class has been superseded by IterativeInverse, which is more flexible and easier to use.
Member RelaxationBlock< MATRIX, inverse_type >::AdditionalData::AdditionalData (const BlockList &block_list, const double relaxation=1., const bool invert_diagonal=true, const bool same_diagonal=false) DEAL_II_DEPRECATED
Since the BlockList is now a data member of this class, it is not recommended anymore to generate it independently.
Member SolverSelector< VECTOR >::SolverSelector (const std::string &solvername, SolverControl &control, VectorMemory< VECTOR > &vector_memory) DEAL_II_DEPRECATED
Use the default constructor, set_control() and select().
Member SparseILU< number >::apply_decomposition (Vector< somenumber > &dst, const Vector< somenumber > &src) const DEAL_II_DEPRECATED
This method is deprecated, and left for backward compatibility. It will be removed in later versions.
Member SparseILU< number >::decompose (const SparseMatrix< somenumber > &matrix, const double strengthen_diagonal=0.) DEAL_II_DEPRECATED
This method is deprecated, and left for backward compability. It will be removed in later versions.
Member SparseILU< number >::SparseILU (const SparsityPattern &sparsity) DEAL_II_DEPRECATED
This method is deprecated, and left for backward compatibility. It will be removed in later versions. Instead, pass the sparsity pattern that you want used for the decomposition in the AdditionalData structure.
Member SparseLUDecomposition< number >::decompose (const SparseMatrix< somenumber > &matrix, const double strengthen_diagonal=0.) DEAL_II_DEPRECATED
Member SparseLUDecomposition< number >::is_decomposed () const DEAL_II_DEPRECATED
Member SparseLUDecomposition< number >::reinit (const SparsityPattern &sparsity) DEAL_II_DEPRECATED
Member SparseLUDecomposition< number >::SparseLUDecomposition (const SparsityPattern &sparsity) DEAL_II_DEPRECATED
This method is deprecated, and left for backward compatibility. It will be removed in later versions. Instead, pass the sparsity pattern that you want used for the decomposition in the AdditionalData structure.
Member SparseMatrix< number >::raw_entry (const size_type row, const size_type index) const DEAL_II_DEPRECATED
Use iterator or const_iterator instead!
Member SparseMatrixIterators::Accessor< number, true >::Accessor (MatrixType *matrix, const size_type row, const size_type index) DEAL_II_DEPRECATED
This constructor is deprecated. Use the other constructor with a global index instead.
Member SparseMatrixIterators::Iterator< number, Constness >::Iterator (MatrixType *matrix, const size_type row, const size_type index) DEAL_II_DEPRECATED
This constructor is deprecated. Use the other constructor with a global index instead.
Member SparseMIC< number >::decompose (const SparseMatrix< somenumber > &matrix, const double strengthen_diagonal=0.) DEAL_II_DEPRECATED
This method is deprecated, and left for backward compability. It will be removed in later versions. Use initialize() instead.
Member SparseMIC< number >::reinit (const SparsityPattern &sparsity) DEAL_II_DEPRECATED
This method is deprecated, and left for backward compatibility. It will be removed in later versions.
Member SparseMIC< number >::SparseMIC (const SparsityPattern &sparsity) DEAL_II_DEPRECATED
This method is deprecated, and left for backward compatibility. It will be removed in later versions. Instead, pass the sparsity pattern that you want used for the decomposition in the AdditionalData structure.
Member SparsityPattern::copy_from (const size_type n_rows, const size_type n_cols, const ForwardIterator begin, const ForwardIterator end, const bool optimize_diagonal) DEAL_II_DEPRECATED
The last argument of this function is ignored. Use the version of this function without the last argument.
Member SparsityPattern::copy_from (const CompressedSparsityType &csp, const bool optimize_diagonal) DEAL_II_DEPRECATED
The last argument of this function is ignored. Use the version of this function without the last argument.
Member SparsityPattern::copy_from (const FullMatrix< number > &matrix, const bool optimize_diagonal) DEAL_II_DEPRECATED
The last argument of this function is ignored. Use the version of this function without the last argument.
Member SparsityPattern::get_column_numbers () const DEAL_II_DEPRECATED
. Use row_length and column_number instead. Also, using iterators may get you most of the information you may want.
Member SparsityPattern::get_rowstart_indices () const DEAL_II_DEPRECATED
This is kind of an expert mode. Get access to the rowstart array, but read-only.
Member SparsityPattern::optimize_diagonal () const DEAL_II_DEPRECATED
The function always returns true if the matrix is square and false if it is not.
Member SparsityPattern::partition (const unsigned int n_partitions, std::vector< unsigned int > &partition_indices) const DEAL_II_DEPRECATED
This function is deprecated. Use SparsityTools::partition instead.
Member SparsityPattern::reinit (const size_type m, const size_type n, const unsigned int max_per_row, const bool optimize_diagonal) DEAL_II_DEPRECATED
The last argument of this function is ignored. Use the version of this function without the last argument.
Member SparsityPattern::reinit (const size_type m, const size_type n, const VectorSlice< const std::vector< unsigned int > > &row_lengths, const bool optimize_diagonal) DEAL_II_DEPRECATED
The last argument of this function is ignored. Use the version of this function without the last argument.
Member SparsityPattern::reinit (const size_type m, const size_type n, const std::vector< unsigned int > &row_lengths, const bool optimize_diagonal) DEAL_II_DEPRECATED
The last argument of this function is ignored. Use the version of this function without the last argument.
Member SparsityPattern::row_begin (const size_type r) const DEAL_II_DEPRECATED
Use the iterators provided by the begin() and end() functions instead.
Member SparsityPattern::row_end (const size_type r) const DEAL_II_DEPRECATED
Use the iterators provided by the begin() and end() functions instead.
Member SparsityPattern::row_iterator
This typedef is deprecated. Use proper iterators instead.
Member SparsityPattern::SparsityPattern (const size_type m, const std::vector< unsigned int > &row_lengths, const bool optimize_diagonal) DEAL_II_DEPRECATED
Use the constructor without the last argument since it is ignored.
Member SparsityPattern::SparsityPattern (const size_type m, const size_type n, const unsigned int max_per_row, const bool optimize_diagonal) DEAL_II_DEPRECATED
Use the constructor without the last argument since it is ignored.
Member SparsityPattern::SparsityPattern (const size_type m, const size_type n, const std::vector< unsigned int > &row_lengths, const bool optimize_diagonal) DEAL_II_DEPRECATED
Use the constructor without the last argument since it is ignored.
Member SparsityPatternIterators::Accessor::Accessor (const SparsityPattern *matrix, const size_type row, const size_type index) DEAL_II_DEPRECATED
This constructor is deprecated. Use the other constructor with a global index instead.
Member SparsityPatternIterators::Iterator::Iterator (const SparsityPattern *sp, const size_type row, const size_type index) DEAL_II_DEPRECATED
This constructor is deprecated. Use the other constructor with a global index instead.
Member TableBase< N, T >::data () const DEAL_II_DEPRECATED
This function accesses data directly and should not be used!
Member Threads::DEAL_II_DEPRECATED

Member Threads::spawn (C &c, RT(C::*fun_ptr)(Arg1, Arg2, Arg3, Arg4, Arg5)) DEAL_II_DEPRECATED
Use new_thread() instead.
Member Threads::spawn (const C &c, RT(C::*fun_ptr)(Arg1, Arg2) const) DEAL_II_DEPRECATED
Use new_thread() instead.
Member Threads::spawn (const C &c, RT(C::*fun_ptr)(Arg1) const) DEAL_II_DEPRECATED
Use new_thread() instead.
Member Threads::spawn (C &c, RT(C::*fun_ptr)(Arg1, Arg2)) DEAL_II_DEPRECATED
Use new_thread() instead.
Member Threads::spawn (RT(*fun_ptr)(Arg1, Arg2, Arg3, Arg4, Arg5, Arg6, Arg7)) DEAL_II_DEPRECATED
Use new_thread() instead.
Member Threads::spawn (C &c, RT(C::*fun_ptr)(Arg1, Arg2, Arg3, Arg4, Arg5, Arg6, Arg7, Arg8)) DEAL_II_DEPRECATED
Use new_thread() instead.
Member Threads::spawn (const C &c, RT(C::*fun_ptr)(Arg1, Arg2, Arg3, Arg4, Arg5) const) DEAL_II_DEPRECATED
Use new_thread() instead.
Member Threads::spawn (const C &c, RT(C::*fun_ptr)(Arg1, Arg2, Arg3) const) DEAL_II_DEPRECATED
Use new_thread() instead.
Member Threads::spawn (C &c, RT(C::*fun_ptr)(Arg1, Arg2, Arg3, Arg4, Arg5, Arg6, Arg7, Arg8, Arg9)) DEAL_II_DEPRECATED
Use new_thread() instead.
Member Threads::spawn (C &c, RT(C::*fun_ptr)(Arg1, Arg2, Arg3, Arg4, Arg5, Arg6, Arg7)) DEAL_II_DEPRECATED
Use new_thread() instead.
Member Threads::spawn (RT(*fun_ptr)(Arg1, Arg2, Arg3, Arg4, Arg5, Arg6)) DEAL_II_DEPRECATED
Use new_thread() instead.
Member Threads::spawn (RT(*fun_ptr)()) DEAL_II_DEPRECATED
Use new_thread() instead.
Member Threads::spawn (const C &c, RT(C::*fun_ptr)(Arg1, Arg2, Arg3, Arg4, Arg5, Arg6, Arg7) const) DEAL_II_DEPRECATED
Use new_thread() instead.
Member Threads::spawn (RT(*fun_ptr)(Arg1, Arg2, Arg3, Arg4, Arg5, Arg6, Arg7, Arg8, Arg9)) DEAL_II_DEPRECATED
Use new_thread() instead.
Member Threads::spawn (C &c, RT(C::*fun_ptr)(Arg1)) DEAL_II_DEPRECATED
Use new_thread() instead.
Member Threads::spawn (RT(*fun_ptr)(Arg1, Arg2, Arg3, Arg4)) DEAL_II_DEPRECATED
Use new_thread() instead.
Member Threads::spawn (C &c, RT(C::*fun_ptr)(Arg1, Arg2, Arg3, Arg4)) DEAL_II_DEPRECATED
Use new_thread() instead.
Member Threads::spawn (C &c, RT(C::*fun_ptr)()) DEAL_II_DEPRECATED
Use new_thread() instead.
Member Threads::spawn (const C &c, RT(C::*fun_ptr)(Arg1, Arg2, Arg3, Arg4, Arg5, Arg6, Arg7, Arg8) const) DEAL_II_DEPRECATED
Use new_thread() instead.
Member Threads::spawn (C &c, RT(C::*fun_ptr)(Arg1, Arg2, Arg3)) DEAL_II_DEPRECATED
Use new_thread() instead.
Member Threads::spawn (const C &c, RT(C::*fun_ptr)() const) DEAL_II_DEPRECATED
Use new_thread() instead.
Member Threads::spawn (const C &c, RT(C::*fun_ptr)(Arg1, Arg2, Arg3, Arg4, Arg5, Arg6) const) DEAL_II_DEPRECATED
Use new_thread() instead.
Member Threads::spawn (RT(*fun_ptr)(Arg1, Arg2, Arg3, Arg4, Arg5)) DEAL_II_DEPRECATED
Use new_thread() instead.
Member Threads::spawn (const C &c, RT(C::*fun_ptr)(Arg1, Arg2, Arg3, Arg4) const) DEAL_II_DEPRECATED
Use new_thread() instead.
Member Threads::spawn (RT(*fun_ptr)(Arg1, Arg2, Arg3)) DEAL_II_DEPRECATED
Use new_thread() instead.
Member Threads::spawn (const C &c, RT(C::*fun_ptr)(Arg1, Arg2, Arg3, Arg4, Arg5, Arg6, Arg7, Arg8, Arg9) const) DEAL_II_DEPRECATED
Use new_thread() instead.
Member Threads::spawn (C &c, RT(C::*fun_ptr)(Arg1, Arg2, Arg3, Arg4, Arg5, Arg6)) DEAL_II_DEPRECATED
Use new_thread() instead.
Member Threads::spawn (RT(*fun_ptr)(Arg1, Arg2)) DEAL_II_DEPRECATED
Use new_thread() instead.
Member Threads::spawn (RT(*fun_ptr)(Arg1, Arg2, Arg3, Arg4, Arg5, Arg6, Arg7, Arg8)) DEAL_II_DEPRECATED
Use new_thread() instead.
Member Threads::spawn (RT(*fun_ptr)(Arg1)) DEAL_II_DEPRECATED
Use new_thread() instead.
Member TimeDependent::end_sweep (const unsigned int n_threads) DEAL_II_DEPRECATED
Use the function without an argument.
Member Triangulation< dim, spacedim >::add_refinement_listener (RefinementListener &listener) const DEAL_II_DEPRECATED
Member Triangulation< dim, spacedim >::clear_user_pointers () DEAL_II_DEPRECATED
User clear_user_data() instead.
Member Triangulation< dim, spacedim >::distort_random (const double factor, const bool keep_boundary=true) DEAL_II_DEPRECATED
Use GridTools::distort_random instead.
Class Triangulation< dim, spacedim >::RefinementListener
Member Triangulation< dim, spacedim >::RefinementListener::copy_notification (const Triangulation< dim, spacedim > &old_tria, const Triangulation< dim, spacedim > &new_tria)
Member Triangulation< dim, spacedim >::RefinementListener::create_notification (const Triangulation< dim, spacedim > &tria)
Member Triangulation< dim, spacedim >::RefinementListener::post_refinement_notification (const Triangulation< dim, spacedim > &tria)
Member Triangulation< dim, spacedim >::RefinementListener::pre_refinement_notification (const Triangulation< dim, spacedim > &tria)
Member Triangulation< dim, spacedim >::RefinementListener::~RefinementListener ()
Member Triangulation< dim, spacedim >::remove_refinement_listener (RefinementListener &listener) const DEAL_II_DEPRECATED
Member TrilinosWrappers::BlockVector::compress (const Epetra_CombineMode last_action) DEAL_II_DEPRECATED
Member TrilinosWrappers::MPI::BlockVector::compress (const Epetra_CombineMode last_action) DEAL_II_DEPRECATED
Member TrilinosWrappers::SparseMatrix::compress () DEAL_II_DEPRECATED
: use compress() with VectorOperation instead.
Member TrilinosWrappers::VectorBase::compress (const Epetra_CombineMode last_action) DEAL_II_DEPRECATED
Use compress(::VectorOperation::values) instead.
Member TrilinosWrappers::VectorBase::compress () DEAL_II_DEPRECATED
: Use the compress(VectorOperation::values) function above instead.
Member types::DEAL_II_DEPRECATED

Old name for the typedef above.

Old name for the typedef above.

Old name for the typedef above.

Old name for the typedef above.

Old name for the typedef above.

Use numbers::invalid_subdomain_id

Use numbers::invalid_subdomain_id

Use numbers::artificial_subdomain_id

Use numbers::artificial_subdomain_id

Use numbers::invalid_dof_index

Use numbers::invalid_dof_index

Old name for the typedef above.

Old name for the typedef above.

Old name for the typedef above.

Old name for the typedef above.

Use numbers::invalid_subdomain_id

Use numbers::artificial_subdomain_id

Use numbers::invalid_dof_index

Old name for the typedef above.

Old name for the typedef above.

Old name for the typedef above.

Old name for the typedef above.

Old name for the typedef above.

Old name for the typedef above.

Use numbers::invalid_subdomain_id

Use numbers::invalid_subdomain_id

Use numbers::artificial_subdomain_id

Use numbers::artificial_subdomain_id

Use numbers::invalid_dof_index

Use numbers::invalid_dof_index

Old name for the typedef above.

Old name for the typedef above.

Old name for the typedef above.

Old name for the typedef above.

Use numbers::invalid_subdomain_id

Use numbers::artificial_subdomain_id

Use numbers::invalid_dof_index

Old name for the typedef above.

Old name for the typedef above.

Member update_cell_normal_vectors
Use update_normal_vectors
Member update_face_normal_vectors
Use update_normal_vectors
Member update_q_points
Update quadrature points
Member update_second_derivatives
Update second derivatives.
Member update_support_points
: this flag has no effect.
Member Utilities::System::calculate_collective_mpi_min_max_avg (const MPI_Comm &mpi_communicator, const double my_value, MinMaxAvg &result) DEAL_II_DEPRECATED
Member Utilities::System::get_n_mpi_processes (const MPI_Comm &mpi_communicator) DEAL_II_DEPRECATED
Member Utilities::System::get_this_mpi_process (const MPI_Comm &mpi_communicator) DEAL_II_DEPRECATED
Member Utilities::System::program_uses_mpi () DEAL_II_DEPRECATED
Member Vector< Number >::scale (const Number factor) DEAL_II_DEPRECATED
This function is deprecated and will be removed in a future version. Use operator *= and operator /= instead.