From f38e6a8a9e9b7c50ce26b17376bfc13e837c6f81 Mon Sep 17 00:00:00 2001 From: David Wells Date: Mon, 20 May 2019 15:55:03 -0400 Subject: [PATCH] Fix doxygen links in the 9.1 changelog. --- doc/news/9.0.1-vs-9.1.0.h | 114 ++++++++++++++++++++------------------ 1 file changed, 61 insertions(+), 53 deletions(-) diff --git a/doc/news/9.0.1-vs-9.1.0.h b/doc/news/9.0.1-vs-9.1.0.h index 26473756bf..15cea0a2c2 100644 --- a/doc/news/9.0.1-vs-9.1.0.h +++ b/doc/news/9.0.1-vs-9.1.0.h @@ -42,8 +42,8 @@ inconvenience this causes.
  • Changed: Tasks of member function - hp::FECollection::find_face_dominating_fe_in_subset() are now divided - into two functions hp::FECollection::find_common_subspace() + hp::FECollection::find_least_face_dominating_fe() are now divided + into two functions hp::FECollection::find_common_fes() and hp::FECollection::find_dominated_fe().
    (Marc Fehling, 2019/04/08) @@ -132,19 +132,20 @@ inconvenience this causes.
  • Changes: The data transfer interface of the class - `parallel::distributed::Triangulation` now requires different kinds of - callback functions. `register_data_attach()` now takes - `std::function(cell_iterator &, CellStatus)>`, - which returns the buffer of the packed data. `notify_ready_to_unpack()` + parallel::distributed::Triangulation now requires different kinds of + callback functions. parallel::distributed::Triangulation::register_data_attach() + now takes `std::function(cell_iterator &, CellStatus)>`, + which returns the buffer of the packed data. + parallel::distributed::Triangulation::notify_ready_to_unpack() requires `std::function::const_iterator &>`, where the last argument describes an iterator range, from which the callback function is allowed to read.
    - Further, the `register_data_attach()` function now requires a boolean - argument `returns_variable_size_data`, which denotes if the registered - pack_callback function interacts with the fixed size (`=false`) or - variable size (`=true`) buffer for data transfer. + Further, parallel::distributed::Triangulation::register_data_attach() + now requires a boolean argument `returns_variable_size_data`, which + denotes if the registered pack_callback function interacts with the fixed + size (`=false`) or variable size (`=true`) buffer for data transfer.
    (Marc Fehling, 2018/07/20)
  • @@ -154,7 +155,7 @@ inconvenience this causes. MatrixCreator::create_boundary_mass_matrix that had mixed number type (real valued for the matrix and complex valued for vectors) have been changed to support complex number types uniformly. This implies that now all - underlying number types of matrix, vectors and AffineConstraint objects + underlying number types of matrix, vectors and AffineConstraints objects have to match; mixed variants are no longer supported.
    (Matthias Maier, 2018/05/25) @@ -173,18 +174,21 @@ inconvenience this causes.
  • - Changed: The OpenCASCADE Manifold classes with names ending in Boundary (i.e., - NormalProjectionBoundary, DirectionalProjectionBoundary, and - NormalToMeshProjectionBoundary) have been deprecated in favor of renamed classes - ending in Manifold (i.e., NormalProjectionManifold, - DirectionalProjectionManifold, and NormalToMeshProjectionManifold). + Changed: The OpenCASCADE Manifold classes with names ending in Boundary + (i.e., OpenCASCADE::NormalProjectionBoundary, + OpenCASCADE::DirectionalProjectionBoundary, and + OpenCASCADE::NormalToMeshProjectionBoundary) have been deprecated in favor + of renamed classes ending in Manifold (i.e., + OpenCASCADE::NormalProjectionManifold, + OpenCASCADE::DirectionalProjectionManifold, and + OpenCASCADE::NormalToMeshProjectionManifold).
    (David Wells, 2018/05/16)
  • Changed: The PolynomialSpace::compute_index() and - PolynomialsP::directional_degree() functions used to return their + PolynomialsP::directional_degrees() functions used to return their information through an array that they received as a reference argument. Instead, they now return a `std::array` by value. @@ -578,7 +582,7 @@ inconvenience this causes.
  • - Improved: The Workstream::run() function is now capable of working with iterator + Improved: The WorkStream::run() function is now capable of working with iterator ranges, or any general iterable object that defines the `begin()` and `end()` of a range of elements to iterate over.
    @@ -708,7 +712,7 @@ inconvenience this causes.
  • - New: Add ArraView::ArrayView() and ArrayView::reinit(value_type *, const std::size_t). + New: Add ArrayView::ArrayView() and ArrayView::reinit(value_type *, const std::size_t).
    (Denis Davydov, 2019/04/02)
  • @@ -752,8 +756,9 @@ inconvenience this causes.
  • - New: Add DynamicSparsityPattern::nonempty_cols()/DynamicSparsityPattern::nonempty_rows() to return columns/rows - stored in the sparsity pattern. + New: Add DynamicSparsityPattern::nonempty_cols() and + DynamicSparsityPattern::nonempty_rows() to return columns/rows stored in the + sparsity pattern.
    (Denis Davydov, 2019/03/20)
  • @@ -767,7 +772,7 @@ inconvenience this causes.
  • - New: FEValuesExtractor classes now have a new method get_name() that returns a unique string identifier + New: FEValuesExtractors classes now have a new method get_name() that returns a unique string identifier for each extractor.
    (Luca Heltai, 2019/03/19) @@ -851,7 +856,7 @@ inconvenience this causes.
  • - Fixed: EllipiticalManifold::push_forward_gradient did previously not take the + Fixed: EllipticalManifold::push_forward_gradient() did previously not take the rotation into account. This is now fixed.
    (Daniel Appel, Martin Kronbichler, 2019/03/05) @@ -891,7 +896,7 @@ inconvenience this causes.
  • New: Hierarchy of finite elements in hp::FECollection objects. Get succeeding and preceding indices via hp::FECollection::next_in_hierarchy() and - hp::FECollection::prev_in_hierarchy(). By default, a hierarchy corresponding + hp::FECollection::previous_in_hierarchy(). By default, a hierarchy corresponding to indices is established. Hierarchy can be overridden via hp::FECollection::set_hierarchy().
    @@ -921,8 +926,9 @@ inconvenience this causes.
  • - New: Function DoFRenumbering::random(dof_handler, level) which allows for a random renumbering - of degrees of freedom on a level in a mutilevel hierarchy. + New: A new function + DoFRenumbering::random(DoFHandlerType &, const unsigned int) which allows for a + random renumbering of degrees of freedom on a level in a mutilevel hierarchy.
    (Conrad Clevenger, 2019/02/19)
  • @@ -1048,12 +1054,12 @@ inconvenience this causes.
  • - Improved: A new dummy enumeration AD::NumberTypes::none has been added. - It exists to represent number types that are scalar arithmetic types, - i.e those that hold no derivatives. They are implemented primarily to - facilitate the use of template meta-programming techniques to switch - between different AD types. This covers the case when the user does not - want an AD type at all, but rather a primitive type. + Improved: A new dummy enumeration Differentiation::AD::NumberTypes::none has + been added. It exists to represent number types that are scalar arithmetic + types, i.e those that hold no derivatives. They are implemented primarily to + facilitate the use of template meta-programming techniques to switch between + different AD types. This covers the case when the user does not want an AD + type at all, but rather a primitive type.
    (Jean-Paul Pelteret, 2019/01/25)
  • @@ -1186,7 +1192,7 @@ inconvenience this causes.
  • - New: Class EllipticalManifold derived from ChartManifold, + New: Class EllipticalManifold derived from ChartManifold, valid only for dim=2 and spacedim=2. It maps points from a system of cartesian coordinates to a system of elliptical coordinates and vice-versa.
    @@ -1202,8 +1208,9 @@ inconvenience this causes.
  • - Fixed: The MatrixFree::initialize() function would sometimes run into an - assertion when ghost faces occur on subdomain interfaces. This is now fixed. + Fixed: The internal::MatrixFreeFunctions::FaceSetup::initialize() function + would sometimes run into an assertion when ghost faces occur on subdomain + interfaces. This is now fixed.
    (Martin Kronbichler, 2018/11/28)
  • @@ -1358,8 +1365,8 @@ inconvenience this causes.
  • - New: Add inverse_Hilbert_space_filling_curve() to map points in dim-dimensional - space to line index of the Hilbert space filling curve. + New: Add Utilities::inverse_Hilbert_space_filling_curve() to map points in + dim-dimensional space to line index of the Hilbert space filling curve.
    (Denis Davydov, 2018/10/05)
  • @@ -1382,10 +1389,11 @@ inconvenience this causes.
  • - New: Class parallel::distributed::CellWeights allows to set the + New: Class parallel::CellWeights allows to set the weight of a cell depending on the number of degrees of freedom associated with it. This guarantees an improved load balancing - in case a hp::DoFHandler is used on a p::d::Triangulation. + in case a hp::DoFHandler is used on a + parallel::distributed::Triangulation.
    (Marc Fehling, 2018/10/01)
  • @@ -1601,14 +1609,14 @@ inconvenience this causes.
  • - Fixed: CUDAWrappers::Vector performs now a deep copy instead of a shallow copy - in its copy assignment operator. + Fixed: LinearAlgebra::CUDAWrappers::Vector performs now a deep copy instead of + a shallow copy in its copy assignment operator.
    (Daniel Arndt, 2018/08/16)
  • - Fixed: MGConstrainedDofs::initialize(...) now handles refinement edges across periodic boundaries correctly. + Fixed: MGConstrainedDoFs::initialize() now handles refinement edges across periodic boundaries correctly.
    (Alexander Knieps, 2018/08/13)
  • @@ -1707,8 +1715,8 @@ inconvenience this causes.
  • - Deprecate project_boundary_values_curl_conforming in favor - of project_boundary_values_curl_conforming_l2. The former + Deprecate VectorTools::project_boundary_values_curl_conforming in favor + of VectorTools::project_boundary_values_curl_conforming_l2. The former has a number of known limitations and bugs.
    (Alexander Grayver, 2018/07/26) @@ -1794,7 +1802,7 @@ inconvenience this causes.
  • - New: The class MatrixFreeFunctions::CellwiseInverseMassMatrix can now also be + New: The class MatrixFreeOperators::CellwiseInverseMassMatrix can now also be used in 1D.
    (Martin Kronbichler, 2018/07/04) @@ -1808,9 +1816,9 @@ inconvenience this causes.
  • - New: Extend get_vector_data_ranges() to return extra element in - the tuple to represent DataComponentInterpretation. The functions - were renamed to get_nonscalar_data_ranges(). + New: Extend DataOutInterface::get_vector_data_ranges() to return extra element + in the tuple to represent DataComponentInterpretation. The functions were + renamed to get_nonscalar_data_ranges().
    (Denis Davydov, 2018/06/21)
  • @@ -1823,8 +1831,8 @@ inconvenience this causes.
  • - Changed: Calling GridGenerator::refine_and_coarsen_fixed_fraction() - and GridGenerator::refine_and_coarsen_fixed_fraction() with values for + Changed: Calling GridRefinement::refine_and_coarsen_fixed_fraction() + and GridRefinement::refine_and_coarsen_fixed_fraction() with values for the coarsen and refine fractions that added to 1.0 in exact arithmetic, but something slightly larger in floating point arithmetic, resulted in an error. These functions are now slightly @@ -1860,8 +1868,8 @@ inconvenience this causes.
  • - Bugfix: Fixed bugs for TrilinosWrapper::SparseMatrix::add(factor, other_matrix) - and TrilinosWrapper::SparseMatrix::copy_from(other_matrix) for the case of + Bugfix: Fixed bugs for TrilinosWrappers::SparseMatrix::add() + and TrilinosWrappers::SparseMatrix::copy_from() for the case of non-contiguous rows.
    (Uwe Koecher, 2018/06/14) @@ -1875,7 +1883,7 @@ inconvenience this causes.
  • - Bugfix: Fixed a bug where VectorDataExchange::ghosts_were_set was + Bugfix: Fixed a bug where internal::VectorDataExchange::ghosts_were_set was not set inside MatrixFree::cell_loop() for block vectors with many blocks.
    -- 2.39.5