From d03168759908c9ad9b1518bd6941490c84d9c4f7 Mon Sep 17 00:00:00 2001 From: Wolfgang Bangerth Date: Mon, 2 Feb 2015 07:14:56 -0600 Subject: [PATCH] Sort changelog entries for deprecated functions. --- doc/news/changes.h | 114 ++++++++++++++++++++++++++++----------------- 1 file changed, 70 insertions(+), 44 deletions(-) diff --git a/doc/news/changes.h b/doc/news/changes.h index eaddd5ddbe..7dc0797df1 100644 --- a/doc/news/changes.h +++ b/doc/news/changes.h @@ -124,70 +124,37 @@ inconvenience this causes. you tried to use them). In almost all cases, there is a function with same name but different argument list that should be used instead. Specifically, the removed functions and classes are: - - TimeDependent::end_sweep (with an argument). - - PointValueHistory::mark_locations. - - The DataPostprocessor::compute_derived_quantities_scalar and - DataPostprocessor::compute_derived_quantities_vector functions without - evaluation points. If you have - data postprocessor classes implemented in your program that overload these - functions, you will have to change it in a way that they overload the - functions of same name but with the evaluation point argument instead. - - The constructors of classes MGSmoother, MGSmootherRelaxation and - MGSmootherPrecondition that take a VectorMemory object. - - Deprecated variants of MeshWorker::loop and MeshWorker::integration_loop. +
+ With headers in deal.II/base/: - ThreadManagement::spawn. - Threads::ThreadCondition and Threads::ThreadMutex. - - GridGenerator::laplace_transformation. - - The version of GridGenerator::parallelogram where the corners are given - as a rank-2 tensor rather than as an array of points. - DataOutBase::create_xdmf_entry with 3 arguments. - DataOutBase::write_hdf5_parallel with 2 arguments. - - Algorithms::ThetaTimestepping::operator(). - - Algorithms::ThetaTimestepping::initialize. - - Algorithms::Newton::initialize. - - MGLevelObject::get_minlevel and MGLevelObject::get_maxlevel. - The versions of FunctionParser::initialize that took a use_degrees or constants argument. The implementation as it is now no longer supports either of these two concepts (since we switched from the FunctionParser library to the muparser library after the deal.II 8.1 release). - - DoFRenumbering::downstream_dg. - - DoFTools::count_dofs_per_component. - - DoFTools::make_sparsity_pattern with a vector-of-vector mask. - GridOutFlags::XFig::level_color. - class BlockList. - - MGConstrainedDoFs::non_refinement_edge_index - - MGConstrainedDoFs::at_refinement_edge_boundary - - The refinement listener concept of the Triangulation class. This - approach to getting notified about what happens to triangulations - has been superseded by the signals defined by the triangulation - class. - The MPI support functions in namespace Utilities and Utilities::System. - Deprecated members of namespace types. - Namespace deal_II_numbers. - - Triangulation::distort_random. - - Triangulation::clear_user_pointers. + +
+ With headers in deal.II/lac/: - The deprecated constructor of SparseILU. - SparseILU::apply_decomposition. - The deprecated constructor of SparseMIC. - The compress() functions without argument in the various vector classes. You should use the versions with a VectorOperation argument instead. - - In FEValues and related classes, the functions that contain the - term 2nd_derivatives were removed in favor of those - with names containing hessian. Similarly, functions - with names including function_grads were removed in - favor of those called function_gradients. Finally, - the cell_normal_vector functions were replaced by - normal_vector ones. In all cases, the new functions - have been around for a while. - Vector::scale. - TrilinosWrappers::*Vector*::compress with an Epetra_CombineMode argument. - SparsityPattern and ChunkSparsityPattern functions that take an optimize_diagonal argument. - SparsityPattern::partition. - - Mapping::transform_covariant and Mapping::transform_contravariant. - The typedef CompressedBlockSparsityPattern. - The deprecated constructors of SparsityPattern iterator classes. - The deprecated variants of DoFTools::make_periodicity_constraints. @@ -200,19 +167,78 @@ inconvenience this causes. parallel::distributed::Vector::scale, parallel::distributed::BlockVector::scale function that takes a scalar as argument. + - PreconditionBlock::size. + - Classes PreconditionedMatrix and PreconditionLACSolver. + - PETScVectors::MPI::Vector constructors and reinit() variants. + - SparseMatrixIterators::Accessor and SparseMatrixIterators::Iterator + constructors. + +
+ With headers in deal.II/deal.II/: + - GridGenerator::laplace_transformation. + - The version of GridGenerator::parallelogram where the corners are given + as a rank-2 tensor rather than as an array of points. - GridTools::create_union_triangulation. - GridTools::extract_boundary_mesh. - - PreconditionBlock::size. + - Triangulation::distort_random. + - Triangulation::clear_user_pointers. + - The refinement listener concept of the Triangulation class. This + approach to getting notified about what happens to triangulations + has been superseded by the signals defined by the triangulation + class. + +
+ With headers in deal.II/fe/: + - In FEValues and related classes, the functions that contain the + term 2nd_derivatives were removed in favor of those + with names containing hessian. Similarly, functions + with names including function_grads were removed in + favor of those called function_gradients. Finally, + the cell_normal_vector functions were replaced by + normal_vector ones. In all cases, the new functions + have been around for a while. + - Mapping::transform_covariant and Mapping::transform_contravariant. + - Classes FEEvaluationDGP, FEEvaluationGeneral and FEEvaluationGL. + +
+ With headers in deal.II/dofs/: + - DoFRenumbering::downstream_dg. + - DoFTools::count_dofs_per_component. + - DoFTools::make_sparsity_pattern with a vector-of-vector mask. + +
+ With headers in deal.II/multigrid/: + - The constructors of classes MGSmoother, MGSmootherRelaxation and + MGSmootherPrecondition that take a VectorMemory object. + - MGLevelObject::get_minlevel and MGLevelObject::get_maxlevel. + - MGConstrainedDoFs::non_refinement_edge_index + - MGConstrainedDoFs::at_refinement_edge_boundary - MGTools::count_dofs_per_component. - MGTools::apply_boundary_values. - MGTools::extract_inner_interface_dofs. - Class MGMatrix. - Multigrid::vmult and friends. - - Classes FEEvaluationDGP, FEEvaluationGeneral and FEEvaluationGL. - - Classes PreconditionedMatrix and PreconditionLACSolver. - - PETScVectors::MPI::Vector constructors and reinit() variants. - - SparseMatrixIterators::Accessor and SparseMatrixIterators::Iterator - constructors. + +
+ With headers in deal.II/mesh_worker/: + - Deprecated variants of MeshWorker::loop and MeshWorker::integration_loop. + +
+ With headers in deal.II/algorithm/: + - Algorithms::ThetaTimestepping::operator(). + - Algorithms::ThetaTimestepping::initialize. + - Algorithms::Newton::initialize. + +
+ With headers in deal.II/numerics/: + - TimeDependent::end_sweep (with an argument). + - PointValueHistory::mark_locations. + - The DataPostprocessor::compute_derived_quantities_scalar and + DataPostprocessor::compute_derived_quantities_vector functions without + evaluation points. If you have + data postprocessor classes implemented in your program that overload these + functions, you will have to change it in a way that they overload the + functions of same name but with the evaluation point argument instead.
This release also removes the deprecated class MGDoFHandler. The functionality of this class had previously been incorporated into -- 2.39.5