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
Changes between Version 9.2.0 and 9.3.0

This is the list of changes made between the release of deal.II version 9.2.0 and that of 9.3.0. All entries are signed with the names of the author.

Incompatibilities

Following are a few modifications to the library that unfortunately are incompatible with previous versions of the library, but which we deem necessary for the future maintainability of the library. Unfortunately, some of these changes will require modifications to application programs. We apologize for the inconvenience this causes.

  1. Removed: An additional overload of GridTools::cell_measure(), which only existed to aid generic programming and only threw an exception, has been removed. If you use this function then the best fix is to ensure that you are not explicitly providing a template parameter to the function itself.
    (David Wells, 2021/05/16)

  2. Renamed: The function ParticleHandler::locally_relevant_ids() has been deprecated. Please use the new function ParticleHandler::locally_owned_particle_ids() instead.
    (Peter Munch, 2021/05/01)

  3. Deprecated: The GridReordering class as well as Triangulation::create_triangulation_compatibility have been deprecated. These functions use the old-style (before 5.2) numbering and have been unofficially deprecated since 2005.
    (David Wells, 2021/04/22)

  4. Removed: The class parallel::distributed::ErrorPredictor has been removed. Use the function hp::Refinement::predict_error() in combination with parallel::distributed::CellDataTransfer instead. Please consult the documentation of hp::Refinement::predict_error() for instructions.
    (Marc Fehling, 2021/04/21)

  5. Changed: The order in which vertices are read from GridIn::read_unv() has changed. As a result the vertex numbers on each cell are now slightly different.
    (David Wells, 2021/04/13)

  6. Changed: The order of parameters has been switched in MappingQCache::initialize(), with the Mapping now being the first argument.
    (Peter Munch, 2020/05/23)

  7. Changed: The various parse_arguments(), to_string(), and to_value() functions related to the Pattern namespace take their last argument by const& instead of const std::unique_ptr<>&.
    (Daniel Arndt, 2021/02/22)

  8. Fixed: GridOut::write_vtk output the vertices of hexahedra in the wrong order, which resulted in visualization programs computing all cell volumes as negative. Fixing this required that we significantly update the way VTK input is read in to deal.II as well (so that GridOut composed with GridIn remains idempotent). As a result, the order of cells, faces, and edges is now different for meshes read from VTK files.
    (David Wells, 2021/02/20)

  9. Changed: The FE_Q_Base class took a description of the polynomial space as a template argument. But that is not necessary: It is entirely sufficient to pass this information to the constructor in the form of a regular constructor argument. This has been changed, and the class has therefore lost its first template argument.
    (Wolfgang Bangerth, 2021/02/03)

  10. Deprecated: ARKode does no longer need a reinit_vector function.
    (Sebastian Proell, 2021/02/01)

  11. Added a simple mesh for debugging purposes that consists of two cubes where one of them can be chosen to have one face either flipped or rotated.
    (Konrad Simon, 2021/01/28)

  12. Updated: deal.II dropped support for Sundials older than version 3.0.0.
    (Matthias Maier, Luca Heltai, 2021/01/25)

  13. Updated: deal.II now requires CMake version 3.1.0 or newer to configure
    (Matthias Maier, 2021/01/25)

  14. Deprecated: All LinearAlgebra::distributed::Vector::zero_out_ghosts() has been deprecated. Use LinearAlgebra::distributed::Vector::zero_out_ghost_values() instead.
    (Peter Munch, 2021/01/04)

  15. Patch to fix issue#7970 for 'RaviartThomas<3>(degree)' elements on meshes that contain cells with faces that are flipped and/or not in standard orientation. The patch provides a possible way to fix other FE classes inheriting from 'FE_PolyTensor' but does not implement it yet. It does not change the interface to FE classes.
    (Konrad Simon, 2020/12/22)

  16. Changed: The interface of FE::fill_fe_face_values() now accepts instead of a Quadrature instance a hp::QCollection instance, enabling the evaluation of shape functions for different quadrature formulas on different faces for FiniteElement classes with supports for this feature (e.g. FE_Q, FE_SimplexP).
    (Peter Munch, 2020/12/12)

  17. Deprecated: The function CellId::to_cell() has been replaced by Triangulation::create_cell_iterator().
    (Marc Fehling, 2020/12/12)

  18. Changed: GridTools::find_active_cell_around_point() no longer throws an exception, but returns an invalid iterator. User codes should now check that the returned cell is valid instead of relying on exceptions, instead of trying to catch exceptions that this function may have thrown.
    (Luca Heltai, 2020/11/30)

  19. Removed: The file affine_constraints.h had a class called IsBlockMatrix that, however, also allowed to check whether its template argument is in fact a block sparsity pattern. The class was likely never intended to be in the public interface, and has been moved to internal::AffineConstraints::IsBlockMatrix and now also internal::AffineConstraints::IsBlockSparsityPattern.
    (Wolfgang Bangerth, 2020/11/29)

  20. Deprecated: The DoFHandlerType template argument for the DataOutStack class has been deprecated. Use DataOutStack<dim, spacedim> instead.
    (Marc Fehling, 2020/11/20)

  21. Deprecation announcement: The template arguments of the following classes will change in a future release:

    If for some reason, you need a code that is compatible with deal.II 9.3 and the subsequent release, a Legacy namespace has been introduced with aliases of these classes with their original interface. You can make the following substitutions to your code for each of the affected classes:

    • X → Legacy::X

    To perform this substitution automatically, you may use a search and replace script like the following made for the bash shell:

    classes=(SolutionTransfer parallel::distributed::SolutionTransfer Functions::FEFieldFunction DataOut DataOut_DoFData DataOutFaces DataOutRotation)
    for c in \${classes[@]}; do
    find /path/to/your/code -type f -exec sed -i -E "/(\w\${c}|\${c}[^<]|Particles::\${c}|distributed::\${c}|^\s*(\/\/|\*))/! s/\${c}/Legacy::\${c}/g" {} \;
    done

    (Marc Fehling, 2020/11/20)

  22. Deprecated: The DoFHandlerType template argument for the functions DataPostprocessorInputs::CommonInputs::set_cell() and DataPostprocessorInputs::CommonInputs::get_cell() has been deprecated. These functions now only work with the basic DoFHandler class. As a consequence, the get_cell() function requires an additional dim template. For example, write: cell=common_inputs.template get_cell<dim>()
    (Marc Fehling, 2020/11/15)

  23. Deprecated: The DoFHandlerType template argument for the MappingFEField class has been deprecated. Use MappingFEField<dim, spacedim, VectorType> instead.
    (Marc Fehling, 2020/11/15)

  24. Deprecated: The variant of the function MatrixFree::get_dof_handler expecting a DoFHandlerType template has been deprecated. Use the template-less variant returning a DoFHandler instead.
    (Marc Fehling, 2020/11/13)

  25. Deprecated: All MatrixFree::reinit() functions without Mapping as argument have been deprecated. Use the functions that explicit provide the Mapping instead.
    (Peter Munch, 2020/11/11)

  26. Deprecated: The operator FiniteElement::operator[] has been deprecated. Use DoFHandler::get_fe() with a specified index instead of code like dof_handler->get_fe()[index].
    (Marc Fehling, 2020/11/11)

  27. Deprecated: The initialization interface for the DoFHandler class has changed. DoFHandler::initialize() and DoFHandler::set_fe() have been deprecated. Instead, use the constructor DoFHandler::DoFHandler(tria) or DoFHandler::DoFHandler() followed by DoFHandler::reinit(tria) to attach a Triangulation tria, and DoFHandler::distribute_dofs() to enumerate degrees of freedom.
    (Marc Fehling, 2020/10/30)

  28. Changed: MatrixFree::loop() only accepts LinearAlgebra::distributed::Vector arguments that have been initialized via MatrixFree::initialize_dof_vector() and are as a consequence globally compatible with the Utilities::MPI::Partitioner within internal::MatrixFreeFunctions::DoFInfo.
    (Peter Munch, Martin Kronbichler, 2020/10/21)

  29. Changed: The return type of the method Mapping::get_vertices() has been changed from std::array to boost::container::small_vector.
    (Peter Munch, 2020/10/16)

  30. Deprecated: The QTrapez class, poorly named because the proper English term is "trapezoidal quadrature rule", has been renamed to QTrapezoid, and the class with the old name has been deprecated.
    (Wolfgang Bangerth, 2020/09/28)

  31. Replaced: Python wrapper for 'merge_triangulations' with a more generic equivalent.
    (Alexander Grayver, 2020/09/01)

  32. Removed: CUDA 9, 10.0, and 10.1 are not supported anymore.
    (Bruno Turcksin, 2020/08/05)

  33. Changed: The template arguments of the classes DoFAccessor and DoFCellAccessor have changed. The template argument DoFHandlerType has been replaced by dimension and space dimension.
    (Peter Munch, 2020/06/24)

  34. Deprecated: The functions MatrixFree::reinit(), which take a vector of hp::DoFHandlers, have been deprecated. Users are asked to provide vectors of DoFhandlers, which may contain hp::DoFHandlers. This is possible now since hp::DoFHandler is deriving from DoFHandler.
    (Peter Munch, 2020/06/03)

  35. Removed: The deprecated class MGCoarseGridLACIteration has been removed.
    (Daniel Arndt, 2020/06/12)

  36. Removed: The header file deal.II/grid/tria_object.h has been removed. It was only used for internal purposes.
    (Wolfgang Bangerth, 2020/06/05)

  37. Changed: The binary representation of the Triangulation and DoFHandler classes created by the function save() with release 9.2 cannot be read anymore with load() due to major internal changes of these classes. This change also affects, i.a., the functions GridIn::read_vtu() and GridOut::write_vtu().
    (Peter Munch, 2020/06/03)

  38. Removed: The deprecated bindings to the legacy NETCDF C++ library have been removed.
    (David Wells, 2020/05/27)

  39. Removed: The deprecated bindings to nanoflann have been removed.
    (David Wells, 2020/05/27)

  40. Changed: The ThreadLocalStorage class has been reimplemented with C++14 STL primitives and does not depend on the TBB library any more. With that the obscure ThreadLocalStorage::get_implementation() function that exposed the underlying TBB container has been removed.
    (Matthias Maier, 2020/05/23)

  41. Removed: The Threads::Task class had an operator== that allowed comparing objects of this type for equality. This operator has been removed. If you want to store objects of this kind in a collection that requires this kind of operator (say, std::set), then you probably can't do so any more in a reasonable way. However, this is exactly what the Threads::TaskGroup class is there for.
    (Wolfgang Bangerth, 2020/05/26)

  42. Deprecated: The class hp::DoFHandler has been deprecated, since the DoFHandler has been extended with its functionalities.
    (Peter Munch, 2020/05/23)

  43. Removed: The following preprocessor definitions have been removed from config.h.in: DEAL_II_NOEXCEPT, DEAL_II_USE_MT_POSIX, DEAL_II_USE_MT_POSIX_NO_BARRIERS
    (Matthias Maier, 2020/05/23)

  44. Removed: The deprecated classes Threads::Mutex::ScopedLock, Threads::ConditionVariable, and deprecated functions Threads::Mutex::acquire(), Threads::Mutex::release(), Threads::n_existing_threads(), Threads::this_thread_id() have been removed.
    (Matthias Maier, 2020/05/22)

  45. Removed: The DEAL_II_WITH_CXX14 and DEAL_II_WITH_CXX17 configuration options have been removed. The library will now be compiled with the default C++ standard enabled by the compiler. This is (as of May 2020) C++14 for all compilers. If you want to override that behavior, please set the C++ standard directly for example by configuring with -DDEAL_II_CXX_FLAGS="-std=c++17", or by setting the environement variable CXXFLAGS="-std=c++17".
    (Matthias Maier, 2020/05/21)

  46. Updated: deal.II now requires a compiler with enabled C++14 support.
    (Matthias Maier, 2020/05/21)

  47. Changed: The polynomial space template argument has been removed from FE_Poly and FE_PolyTensor.
    (Graham Harper, Daniel Arndt, 2020/05/21)

  48. Removed: The deprecated class Threads::PosixThreadBarrier has been removed.
    (Wolfgang Bangerth, 2020/04/21)

General

  1. New: The step-78 tutorial program solves the Black-Scholes equations.
    (Tylor Anderson, 2021/05/19)

  2. New: The step-79 tutorial program demonstrates solution of a topology optimization problem.
    (Justin O'Connor, 2021/05/19)

  3. New: The step-66 tutorial program shows how to solve a nonlinear PDE in parallel with MatrixFree methods.
    (Fabian Castelli, 2021/05/19)

  4. New: The class FEPointEvaluation provides an interface to the evaluation of interpolated solution values and gradients on cells on arbitrary reference point positions. These points can change from cell to cell, both with respect to their quantity as well to the location. The two typical use cases are evaluations on non-matching grids and particle simulations.
    (Martin Kronbichler, 2021/05/18)

  5. New: The step-72 tutorial revisits step-15 (that solves a nonlinear elliptic problem using Newton's method). In this variant, automatic differentiation is used either to linearize the residual, or to compute the full linear system from an energy functional.
    (Jean-Paul Pelteret, 2021/05/06)

  6. New: The step-71 tutorial demonstrates how automatic and symbolic differentiation can be leveraged to compute the derivatives of a coupled constitutive law.
    (Jean-Paul Pelteret, 2021/05/06)

  7. New: The step-77 tutorial explores one of the mentioned extensions to step-15, namely implementing a proper step length control algorithm. It uses the KINSOL nonlinear solver package from the SUNDIALS library to incorporate a line search method into the incremental update for Newton's method.
    (Wolfgang Bangerth, 2021/05/04)

  8. New: The step-75 tutorial program shows how to solve a simple Laplace equation in parallel with hp-adaptive and MatrixFree methods.
    (Marc Fehling, Peter Munch, Wolfgang Bangerth, 2021/04/15)

  9. New: Experimental support for simplex meshes (i.e., meshes consisting of triangle or tetrahedron cells) and mixed meshes (i.e., meshes consisting of lines, triangles, quadrilateral, tetrahedron, pyramid, wedge, and/or hexahedron cells) has been added. The new features are presented in the test folder tests/simplex and in the new "Simplex" module page.
    (various, 2021/03/04)

  10. New: The class Utilities::MPI::RemotePointEvaluation and the function VectorTools::point_values() allow to work on arbitrary distributed points.
    (Peter Munch, Martin Kronbichler, Magdalena Schreter, Niklas Fehn, 2021/02/28)

  11. New: The communicator of an arbitrary (not just parallel) Triangulation class can now be queried via Triangulation::get_communicator() or DoFHandler::get_communicator(). In the case of serial Triangulations and DoFHandler set up with serial Triangulations, MPI_COMM_SELF is returned.
    (Peter Munch, 2021/02/28)

  12. New: The behavior of the local_size() member function is not consistent across all vector classes that support ghost elements. As a remedy theis member function is deprecated and replaced by locally_owned_size() that returns the number of locally owned elements (in particular without ghost elements).
    (Daniel Arndt, David Wells, 2021/02/11)

  13. New: Added a new quadrature rule QWitherdenVincent for simplices.
    (David Wells, 2021/02/08)

  14. New: Added a new class BarycentricPolynomial that makes defining polynomials on simplices much easier.
    (David Wells, 2021/01/26)

  15. New: Added a new finite element FE_SimplexP_Bubbles suitable for using mass lumping on simplex meshes.
    (David Wells, 2021/01/26)

  16. New: The step-74 tutorial implements the symmetric interior penalty Galerkin (SIPG) method for Poisson's equation using the FEInterfaceValues class (for interface terms) in conjunction with the MeshWorker::mesh_loop() concept.
    (Timo Heister, Jiaqi Zhang, 2021/01/04)

  17. Improved: Update SUNDIALS ARKODE interface to support versions > 4.0.0 and add preconditioner support
    (Sebastian Proell, 2020/12/11)

  18. New: Added capacity to update ghost particles without rebuilding them from scratch in the particle_handler
    (Bruno Blais, Peter Munch, 2020/11/10)

  19. New: Tutorial example (step-68) showcasing parallel simulation of the advection of particles including load balancing.
    (Bruno Blais, Toni El Geitani Nehme, Rene Gassm ller, Peter Munch, 2020/05/23)

  20. New: The step-19 tutorial program shows how to use particle methods.
    (Wolfgang Bangerth, Rene Gassmoeller, Peter Munch, 2020/09/15)

  21. New: The GridIn class can now read ExodusII files when deal.II is configured with Trilinos and SEACAS.
    (David Wells, 2020/09/09)

  22. Changed: The internal data structures of DoFHandler have been modified to use compressed row storage, enabling it to also handle hp::DoFHandler functionalities. Currently, the user can choose between the normal mode and the hp mode during calling the constructur. Please note that the multigrid functionalities are only available during normal mode.
    (Peter Munch, 2020/05/23)

Specific improvements

  1. Fixed: Make SUNDIALS::IDA function names consistent with SUNDIALS::KINSOL function names.
    (Luca Heltai, 2021/05/21)

  2. Fixed: KINSOL interface is now fully working
    (Luca Heltai, Nicola Giuliani, 2021/05/19)

  3. Improved: The images in tutorial 35 have been updated to cold and hot color scheme with higher resolution and more consistent sizing.
    (Bryn Barker, 2021/05/18)

  4. New: SUNDIALS::IDA is now compatible with SUNDIALS > 4.0.0
    (Nicola Giuliani, Luca Heltai, 2021/05/13)

  5. Improved: ParticleHandler::sort_particles_into_subdomains_and_cells() now uses a faster method to identify particles in cells farther away from their previous cell.
    (Martin Kronbichler, 2021/05/12)

  6. Fixed: DataOutBase::write_ucd() has been fixed to output vertices in the correct order. Previously, cells were tangled when read with Paraview's AVS-UCD reader.
    (David Wells, 2021/05/06)

  7. Fixed: The function Particles::Generators::probabilistic_locations could crash if some MPI ranks had no active cells. This is fixed now.
    (Rene Gassmoeller, 2021/05/05)

  8. Improved: There is now a cache for TriaAccessor::vertex_index() for the cells of a mesh, which considerably speeds up operations with intensive use of cell->vertex() or cell->vertex_index().
    (Martin Kronbichler, 2021/05/04)

  9. New: Add a function taylor_estimate_function_bounds, which estimates the range of the value and gradient components of a Function<dim> over a BoundingBox<dim>, by approximating the function by a 2nd order Taylor polynomial.
    (Simon Sticko, 2021/04/25)

  10. Deprecated: The FEValuesViews::Scalar, FEValuesViews::Vector, FEValuesViews::Tensor, and FEValuesViews::SymmetricTensor classes all have OutputType structures that defined the types of evaluating the values and derivatives of finite element fields at quadrature points. These structures have been deprecated, and the corresponding types are now defined via local using declarations in the classes mentioned above.
    (Wolfgang Bangerth, 2021/04/25)

  11. Bugfix: FE_Nedelec<2>::convert_generalized_support_point_values_to_dof_values() now works correctly for every degree.
    (Jake Harmon, 2021/04/22)

  12. Fixed: The function hp::Refinement::predict_error() produced incorrect results for p-coarsening.
    (Marc Fehling, 2021/04/21)

  13. Deprecated: The TriaAccessor::number_of_children() function has been deprecated in favor of the new TriaAccessor::n_active_descendants() function.
    (Wolfgang Bangerth, 2021/04/20)

  14. Added: The MPI_InitFinalize RAII class has gained an MPI_InitFinalize::signals::at_mpi_init and an MPI_InitFinalize::signals::at_mpi_finalize signal that are triggered immediately after initializing the MPI context with MPI_Init and immediately before deinitializing the MPI context with MPI_Finalize.
    (Matthias Maier, 2021/04/19)

  15. New: There are now versions of the constructors of the Functions::InterpolatedTensorProductGridData and Functions::InterpolatedUniformGridData classes that move the data in the arguments given, instead of copying it.
    (Wolfgang Bangerth, 2021/04/19)

  16. Fixed: Work around a memory leak issue in OpenMPI 4.1.0 triggered by our Utilities::MPI::min_max_avg() function by repeatedly allocating and freeing MPI_Datatype handles.
    (Matthias Maier, 2021/04/18)

  17. New: FEInterfaceValues now can use FEValuesExtractors to extract scalar or vector components like FEValues does.
    (Jiaqi Zhang, 2021/04/15)

  18. New: The functions AlignedVector::replicate_across_communicator() and Table::replicate_across_communicator() allow copying information across MPI processes.
    (Wolfgang Bangerth, 2021/04/28)

  19. New: Now the HDF5 interface can set bool attributes.
    (Daniel Garcia-Sanchez, 2021/04/03)

  20. Add a new grid generator (subdivided_cylinder) which generates a cylinder with a number of x subdivisions which is specified by the user. Alter cylinder so that it also uses this new generator to prevent code duplication.
    (Bruno Blais, 2021/04/01)

  21. Add: Adds new settings to PETScWrappers::PreconditionBoomerAMG::initialize() in the struct PETScWrappers::PreconditionBoomerAMG::AdditionalData.
    (Maximilian Bergbauer, 2021/03/31)

  22. Deprecated: The version of DoFTools::extract_boundary_dofs() that returns its information via an IndexSet reference argument has been deprecated. Use the version of the function that returns information via an IndexSet return type instead.
    (Wolfgang Bangerth, 2021/03/30)

  23. Deprecated: The version of DoFTools::extract_boundary_dofs() that returns its information via a std::vector<bool> has been deprecated. Use the version of the function that returns information via an IndexSet instead.
    (Wolfgang Bangerth, 2021/03/30)

  24. New: Class parallel::distributed::TemporarilyMatchRefineFlags that temporarily modifies the refine and coarsen flags of all active cells on a parallel::distributed::Triangulation to match its p4est oracle.
    (Marc Fehling, 2021/03/29)

  25. New: The getter function for the divergence in FEEvaluationAccess<1, 1, Number, is_face, VectorizedArrayType>::get_divergence() is now also implemented for dim==1 and n_components==1. The function FEEvaluationAccess<1, 1, Number, is_face, VectorizedArrayType>::submit_gradient() now also takes a rank 2 tensor as input argument.
    (Magdalena Schreter, Peter Munch, Martin Kronbichler, 2021/03/22)

  26. New: Add nearest neighbor predicate support to ArborXWrappers::BVH(). This allows to find the n closest bounding boxes or points to any given bounding box or point.
    (Bruno Turcksin, 2021/03/19)

  27. Improved: The function parallel::distributed::Triangulation::copy_triangulation() now also works with locally refined meshes of type parallel::distributed::Triangulation.
    (Marc Fehling, 2021/03/19)

  28. Improved: The class LinearAlgebra::ReadWriteVector now also can import from Vector and LinearAlgebra::Vector.
    (Peter Munch, 2021/03/18)

  29. New: Adds the new generalized MPI_Bcast function Utilities::MPI::broadcast() for arbitrary data types T.
    (Maximilian Bergbauer, 2021/03/18)

  30. Fixed: MatrixFree::get_boundary_id() would previously only support boundary ids between 0 and 255 via an unsigned char type. This has now been changed to the correct types::boundary_id type, supporting also larger boundary ids.
    (Martin Kronbichler, 2021/03/16)

  31. New: Added Functions::IdentityFunction.
    (David Wells, 2021/03/16)

  32. New: The new method Differentiation::SD::BatchOptimizer::extract() allows one to extract results from previous evaluation of the symbolic expressions. This means that one can safely use a single instance of a batch optimizer to pre-compute a set of results, cache them, and then later extract some results from the cached data without re-evaluating any symbolic expressions.
    (Jean-Paul Pelteret, 2021/03/13)

  33. Improved: The result type deduction for the product of symbolic types (specifically, Differentiation::SD::Expression) with tensors and symmetric tensors has been improved.
    (Jean-Paul Pelteret, 2021/03/13)

  34. New: The MeshWorker::ScratchData class is now able to compute the Laplacians of the scalar-valued and vector-valued components of the solution vector.
    (Jean-Paul Pelteret, 2021/03/13)

  35. Improved: The MeshWorker::ScratchData::get_general_data_storage() method now has a const variant.
    (Jean-Paul Pelteret, 2021/03/13)

  36. Improved: The function VectorTools::get_position_vector() can now also take a Mapping object as input parameter.
    (Peter Munch, 2021/03/10)

  37. New: MappingQCache has new initialize functions. One set of functions takes either a std::function or a Function for transforming individual points. Another set of functions take global vectors (and MGLevelObjects of global vectors) and use these to initialize the position of the support points much like MappingFEField does.
    (Niklas Fehn, Martin Kronbichler, Peter Munch, 2021/03/10)

  38. New: Utilities::MPI::logical_or() for collective logical or operations.
    (Marc Fehling, 2021/03/04)

  39. New: Add a component parameter to FESeries::Fourier/Legendre to make them working with non-primitive elements.
    (Ce Qin, 2021/03/01)

  40. New: A new class GridTools::MarchingCubeAlgorithm has been added. It helps to create a surface mesh on the iso line/contour of a scalar field.
    (Peter Munch, Magdalena Schreter, Martin Kronbichler, 2021/02/28)

  41. New: Function hp::Refinement::limit_p_level_difference() restricts the maximal level difference of neighboring cells with respect to the finite element hierarchy of the registered hp::FECollection.
    (Marc Fehling, 2021/02/23)

  42. New: The new MGTransferBase::prolongate_and_add() performs a prolongation without zeroing out the destination vector.
    (Martin Kronbichler, 2021/02/22)

  43. New: Member function hp::FECollection::get_hierarchy_sequence() returning the sequence of finite element indices that correspond to the registered hierarchy.
    (Marc Fehling, 2021/02/22)

  44. Fixed: deal.II should now be able to use versions of LAPACK compiled with Fortran compilers that do not adhere to the usual Fortran mangling convention.
    (David Wells, 2021/02/20)

  45. Added a template version of CUDAWrappers::MatrixFree::reinit() that takes an IteratorFilters object. This allows to perform the operator evaluation on part of the domain.
    (Bruno Turcksin, 2021/02/19)

  46. Added: A multidimensional array ndarray that allows one to conveniently create "stacked" std::array objects that model a multidimensional array. ndarray<double, 1, 2, 3, 4> for example is a short-hand for std::array<std::array<std::array<std::array<double, 4>, 3>, 2>, 1>.
    (Matthias Maier, 2021/02/19)

  47. Moved: The CommunicationPatternBase class has been moved from the LinearAlgebra namespace into the more general Utilities::MPI namespace.
    (David Wells, 2021/02/15)

  48. Fixed: CutOffFunctionTensorProduct::gradient() was computing the wrong gradient. This is now fixed.
    (Luca Heltai, 2021/02/13)

  49. New: ArrayView objects can now also be constructed from C-style arrays.
    (Wolfgang Bangerth, 2021/02/09)

  50. New: The method parallel::distributed::Triangulation::load() can now also accept a p4est/p8est forest, which can be queried from an existing triangulation via parallel::distributed::Triangulation::get_p4est().
    (Marc Fehling, Peter Munch, 2021/02/09)

  51. New: There are now functions Utilities::get_bit() and Utilities::set_bit() that do as their names suggest.
    (Peter Munch, Wolfgang Bangerth, 2021/02/05)

  52. Improved: AffineConstraints::copy_from() now also works for differing number template types.
    (Peter Munch, Maximilian Bergbauer, 2021/02/05)

  53. Update: class PETScWrappers::PreconditionerBase renamed to PETScWrappers::PreconditionBase for consistency.
    (Pasquale Claudio Africa, 2021/02/03)

  54. Fixed: Triangulation::get_manifold_ids() was not returning all ids correctly.
    (Luca Heltai, 2021/02/03)

  55. New: SUNDIALS N_Vector module now directly operates on different deal.II vectors without internally creating copies. In particular, ARKode can now also be used with LinearAlgebra::distributed::(Block)Vector.
    (Sebastian Proell, 2021/01/31)

  56. Improved: Exception texts are now formatted and broken to fixed-length lines, rather than flowing to arbitrary lengths.
    (Wolfgang Bangerth, 2021/01/25)

  57. New: Added support for gmsh library API. This allows using GridIn::read_msh() and GridOut::write_msh() to save and read also manifold id information.
    (Luca Heltai, 2021/01/20)

  58. New: implemented p::f::Triangulation::load()/save() for use with p::d::SolutionTransfer.
    (Pasquale Claudio Africa, Peter Munch, 2021/01/18)

  59. Improved: provide abstract interface to p::d::Triangulation::load()/save().
    (Pasquale Claudio Africa, 2021/01/18)

  60. New: Added python wrappers to enable support for simplex and mixed meshes.
    (Alexander Grayver, 2021/01/18)

  61. New: Mapping::get_bounding_box() now returns the bounding box of the support points, when the mapping is of type MappingQ, MappingQGeneric, and MappingQEulerian.
    (Luca Heltai, 2021/01/16)

  62. New: The method parallel::distributed::Triagnulation::communicate_locally_moved_vertices() has been refactored and moved to parallel::DistributedTriangulationBase so that it can now also be used for parallel::fullydistributed::Triangulation.
    (Daniel Arndt, Ivan Fumagalli, Peter Munch, 2021/01/15)

  63. New: Implemented MappingFE::transform_real_to_unit_cell().
    (Luca Heltai, 2021/01/13)

  64. New: The old tensor basis transformation functions internal::Physics::transformation_contraction() have been moved out of the internal namespace and renamed to Physics::Transformations::basis_transformation() and have documentation now.
    (Nils Much, 2021/01/12)

  65. New: Created two new methods ParameterAcceptor::enter_subsection() and ParameterAcceptor::leave_subsection() that allow more intricated parameter paths within ParameterAcceptor classes.
    (Luca Heltai, 2021/01/12)

  66. New: Add new BVH (Bounding Volume Hierarchy) class based on ArborX. This class performs multiple kinds of geometric search: intersection of bounding boxes and intersection of bounding boxes with points.
    (Bruno Turcksin, 2021/01/08)

  67. New: Function GridTools::get_subdomain_association() determines the owning process of any valid cell on a Triangulation that is represented by a globally unique CellId.
    (Marc Fehling, 2021/01/07)

  68. New: The policy under which things in deal.II are deprecated has changed. Deprecated features are now first marked with DEAL_II_DEPRECATED_EARLY until the next release of the library, at which point they will be remarked with DEAL_II_DEPRECATED. By default, things marked with DEAL_II_DEPRECATED_EARLY do not print deprecation warnings - this is controlled with the DEAL_II_EARLY_DEPRECATIONS CMake configuration option. This change was made so that users can use multiple recent checkouts of the development branch without needing to address the problem that some will print deprecation warnings and others do not, and also so that new deprecation warnings do not appear outside of the release period.
    (Daniel Arndt, 2021/01/05)

  69. Fixed: Reset time and timestep_number during pre refinement steps in step-26.
    (Praveen Chandrashekar, 2021/01/05)

  70. Changed: Tutorial step-27 has been simplified and now uses the recently introduced SmoothnessEstimator namespace.
    (Marc Fehling, 2020/12/24)

  71. Fixed: DoFTools::make_periodicity_constraints() was not instantiated for condition 'dim < spacedim'. The instantiation was corrected and a test was added to verify that the function works for such condition.
    (Malhar Tidke, 2020/12/23)

  72. Improved: If there is an uncaught exception the destructor of the HDF5 interface does not call H5Dclose, H5Gclose or H5Fclose. In addition, to avoid MPI synchronization and a possible deadlock, the destructor calls MPI_Abort(). (Daniel Garcia-Sanchez, 2020/12/23)

  73. New: Add functions CUDAWrappers::local_q_point_id_host(), CUDAWrappers::get_quadrature_point_host(), CUDAWrappers::copy_mf_data_to_host(), and CUDAWrappers::MatrixFree::get_colored_graph(). These functions can be used to evaluate material properties in the same order on the host and on the device.
    (Bruno Turcksin, 2020/12/06)

  74. Fixed: A previous patch accidentally broke step-46 and led to exceptions about accessing neighboring cells that don't actually exist because a cell is at the boundary. This has been fixed.
    (Wolfgang Bangerth, 2020/12/03)

  75. New: The function GridGenerator::convert_hypercube_to_simplex_mesh allows to convert a given triangulation based on quadrilaterals (2D) or hexahedra (3D) to a triangulation based on simplices or tetraedra, respectively. Thereby, material_IDs and boundary_IDs are inherited from the given triangulation.
    (Elias Dejene, Peter Munch, 2020/11/23)

  76. New: A new class LowStorageRungeKutta is added to the namespace TimeStepping to implement the explicit low-storage Runge-Kutta methods, see [119] and step-67.
    (Jiaqi Zhang, 2020/11/18)

  77. Improved: QCollection<dim> now also accepts Quadrature<1> and converts this input quadrature rule to a dim-dimensional quadrature rule internally via tensor product. Furthermore, a copy constructor has been added accepting QCollection<1>.
    (Peter Munch, 2020/11/12)

  78. Fixed: WorkStream::mesh_loop() should now work on anisotropic grids.
    (Luca Heltai, 2020/11/03)

  79. Improved: An inverse quadratic approximation has been added for the pull-back operation in the TransfiniteInterpolationManifold::new_points() function. The better initial guesses for the Newton/Broyden iteration make the computation faster and more robust in some difficult scenarios.
    (Martin Kronbichler, 2020/11/01)

  80. Fixed: There was a bug in Differentiation::AD::ScalarFunction::extract_hessian_component() that was triggered when using a symmetric tensor extractor with a non-zero first component index. Having previously lead to either incorrect results being returned or valid user programs crashing, it has now been corrected.
    (Jean-Paul Pelteret, 2020/11/01)

  81. Improved: MatrixFree now also works for hp in MPI-parallelized programs.
    (Marc Fehling, Katharina Kormann, Martin Kronbichler, Peter Munch, 2020/10/20)

  82. New: step-9 uses the "streamline-upwind Petrov-Galerkin" method, but does not make any attempt at explaining what this method is or why it might be named like this. This has been rectified: The introduction now has a long section that explains the origin of the method and its name.
    (Wolfgang Bangerth, 2020/10/10)

  83. New: Mapping::transform_points_real_to_unit_cell() can compute the operation of Mapping::transform_real_to_unit_cell() on many points simultaneously, which can be much faster for MappingQGeneric and derived classes that involve expensive operations to compute the support points of the mapping.
    (Martin Kronbichler, 2020/10/07)

  84. New: GridRefinement::refine_and_coarsen_fixed_fraction() and parallel::distributed::GridRefinement::refine_and_coarsen_fixed_fraction() now allow to specify a VectorTools::NormType, which determines how combined errors on subsets of cells will be calculated.
    (Marc Fehling, 2020/10/06)

  85. New: SSP_THIRD_ORDER is added to the namespace TimeStepping to implement the explicit third order Strong Stability Preserving (SSP) Runge-Kutta method, which is also called the third order Total Variation Diminishing (TVD) Runge-Kutta method, see [92].
    (Jiaqi Zhang, 2020/10/05)

  86. New: GridTools::affine_cell_approximation() returns a matrix A and offset vector b that describe a least-squares fit of an affine approximation to a set of vertices of a cell.
    (Martin Kronbichler, 2020/10/04)

  87. New: Helper functions CellAccessor::child_iterators() and DoFCellAccessor::child_iterators() which return iterators to children of a cell via cell->child_iterators().
    (Marc Fehling, 2020/10/03)

  88. New: CellId has a new constructor to create it from a std::string.
    (Timo Heister, 2020/10/05)

  89. Improved: MappingQGeneric::transform_real_to_unit_cell() has been made much faster by directly working with the tensor product form of the mapping shape functions and avoiding many unnecessary memory allocations. The main cost is now MappingQGeneric::compute_mapping_support_points(), which can be made fast with MappingQCache, for example.
    (Martin Kronbichler, 2020/09/30)

  90. New: The function BlockSparsityPattern::print_svg() outputs a block sparsity pattern in SVG format.
    (Wolfgang Bangerth, 2020/09/25)

  91. Changed: step-29 no longer uses the deallog variable to generate output, but instead directly writes to std::cout.
    (Wolfgang Bangerth, 2020/09/23)

  92. New: The classes FEEvaluation and FEFaceEvaluation with template parameter -1 for the polynomial degree is now based on pre-compiled templated code for polynomial degrees between 1 and 6. This allows for fast execution of matrix-free evaluation for run-time polynomial degrees. The generated instantiations are controlled by include/deal.II/matrix_free/evaluation_template_factory.templates.h and can be pre-compiled for additional degrees in user code.
    (Martin Kronbichler, Peter Munch, 2020/09/21)

  93. Fixed: Our cmake scripts forgot to install some of the files that are part of the code gallery. This is now fixed.
    (Wolfgang Bangerth, 2020/09/17)

  94. Fixed: DoFTools::extract_dofs() return an IndexSet as result used to have a quadratic complexity in the number of extracted indices. This is now fixed.
    (Martin Kronbichler, 2020/08/11)

  95. Added: method for returning list of all triangulation cells.
    (Alexander Grayver, 2020/09/03)

  96. Added: python wrapper for GridTools::replicate_triangulation, more general version of the GridTools::merge_triangulations is implemented
    (Alexander Grayver, 2020/09/01)

  97. New: The methods FEEvaluation::gather_evaluate(), FEEFaceEvaluation::gather_evaluate(), FEEvaluation::integrate_scatter() and FEfaceEvaluation::integrate_scatter() can now also accept block vectors.
    (Peter Munch, Magdalena Schreter, Martin Kronbichler, 2020/08/31)

  98. New: A particle collection can now be copied into a new ParticleHandler object using the new ParticleHandler::copy_from function.
    (Rene Gassmoeller, 2020/08/28)

  99. Added: DataOut now supports HDF5 file format with simplex meshes.
    (Pasquale Claudio Africa, 2020/08/27)

  100. Updated: GridTools::transform() now works with simplex meshes.
    (Pasquale Claudio Africa, 2020/08/26)

  101. Improved: The macro DEAL_II_PICKUP_TESTS can now also be run with on optional input parameter that can be used to manipulate the folder name of tests during ctest.
    (Peter Munch, 2020/07/23)

  102. New: The test suite can now also be run with .json files.
    (Peter Munch, 2020/08/17)

  103. Improved: The definitions of the templated functions of the HDF5 interface are now in hdf5.h, therefore it is possible to use additional template combinations. The instantiations are no longer necessary, therefore they have been removed.
    (Daniel Garcia-Sanchez, 2020/08/14)

  104. New: MGTools::make_sparsity_pattern() can now take an optional AffineConstraints argument to add the effect of, e.g., periodic boundary conditions.
    (Martin Kronbichler, 2020/08/11)

  105. Fixed: The DataPostprocessorTensor class erroneously announced that the components of its output are a bunch of scalars when, of course, the whole point of the class was to output things as one tensor field. This is now fixed.
    (Wolfgang Bangerth, 2020/08/06)

  106. New: GridIn::read_vtk() now supports triangular and tetrahedral meshes.
    (Peter Munch, 2020/07/23)

  107. New: GridIn::read_msh() now supports triangular and tetrahedral meshes.
    (Daniel Paukner, 2020/07/20)

  108. New: The method hp::FEFaceValues::reinit() can now also accept face iterators.
    (Peter Munch, 2020/07/16)

  109. New: The class hp::MappingCollection has a new constructor. This constructor creates a MappingCollection from one or more mapping objects passed to the constructor.
    (Peter Munch, 2020/07/15)

  110. Fixed: MeshWorker::mesh_loop() did not work on 1d with refined grids. This is now fixed.
    (Luca Heltai, 2020/07/08)

  111. Added the functions CUDAWrappers::MatrixFree::get_vector_partitioner() and CUDAWrappers::MatrixFree::get_dof_handler()
    (Bruno Turcksin, 2020/07/06)

  112. Fixed: In parallel hp-adaptive applications, DoFHandler::distribute_dofs() no longer fails to enumerate degrees of freedom on ghost interfaces if continuous finite elements do not dominate each other.
    (Marc Fehling, 2020/07/03)

  113. New: A new quadrature rule for simplex geometric entities has been added.
    (Peter Munch, 2020/07/02)

  114. New: Geometric objects of a Triangulation are assigned a ReferenceCell::Type. The value can be queried via TriaAccessor::reference_cell_type().
    (Peter Munch, 2020/06/30)

  115. New: The class ArrayView can now also be constructed from std::array.
    (Peter Munch, 2020/06/29)

  116. New: BoundingBox::real_to_unit() and BoundingBox::unit_to_real() allow one to apply both the direct and the inverse transformation that are needed to map the unit bounding box to the current box, and viceversa.
    (Luca Heltai, 2020/06/29)

  117. New: The member function DiscreteTime::set_next_step_size() is added.
    (Reza Rastak, 2020/06/27)

  118. New: There is now a constructor for class Tensor that takes an initializer from an object of type ArrayView.
    (Wolfgang Bangerth, 2020/06/27)

  119. Fixed: The class parallel::distributed::SolutionTransfer can now also handle FE_Nothing.
    (Dominic Soldner, Peter Munch, 2020/06/24)

  120. Fixed: FEInterfaceValues now works also for codim one and two. Instantiated also DoFTools::make_flux_sparsity_pattern() for codim one and two.
    (Luca Heltai, 2020/06/24)

  121. New: The class TriaAccessor provides now the capability to query the number of vertices, lines, and faces (with n_vertices(), n_lines(), n_faces(), vertex_indices(), line_indices(), face_indices()). The new methods can be used as an alternative to the methods in GeometryInfo.
    (Peter Munch, 2020/06/23)

  122. New: Added FEInterfaceValues to MeshWorker::ScratchData.
    (Luca Heltai, 2020/06/23)

  123. Fixed: The ParticleHandler::insert_particles() function forgot to associate particles with the common property pool. Consequently, setting properties on particles added to a ParticleHandler this way led to an error.
    (Andrew Davis, Wolfgang Bangerth, 2020/06/23)

  124. New: Particles::Particle and Particles::ParticleAccessor can now be used as indexable in boost::rtree objects.
    (Luca Heltai, 2020/06/15)

  125. New: Each cell is assigned a globally unique active cell index and (if requested) a level cell index. These indices are integers enumerated contiguously within each subdomain of the mesh. Users can query locally-owned and ghost cells for their indices via CellAccessor::global_active_cell_index() or CellAccessor::global_level_cell_index(). The value is managed automatically by the Triangulation classes. Furthermore, triangulations deriving from parallel::TriangulationBase provide partitioners for these indices, which can be used to set up ghosted vectors with one entry per cell.
    (Peter Munch, 2020/06/12)

  126. New: The function Particles::ParticleHandler::add_global_particles() now takes another optional argument, that allows one to set ids arbitrarily. Moreover, now the numbering of the ids is correct also if we call the method more than one time. Newly added particles, if ids are not specified, now correctly get the first available ids. Added a new version of Particles::ParticleHandler::add_global_particles() that takes a vector of Particles::Particle objects instead of just their positions. This can be used in conjunction with the signal Particles::ParticleHandler::Signals::particle_lost() to reinsert Particles::Particle objects that went out of the locally owned and ghost cells.
    (Luca Heltai, 2020/06/11)

  127. Fixed: The AffineConstraints class had a bug where, if deal.II was compiled without threading, the class used a global variable. If a user program used threads nonetheless, this global variable led to race conditions. This is now fixed.
    (Wolfgang Bangerth, 2020/06/11)

  128. Fixed: Fix a bug where CUDAWrappers::MatrixFree::cell_loop() would set the destination vector to zero if the partitioner of the MatrixFree object was different from the partitioner of the source or destination vector.
    (Bruno Turcksin, 2020/06/10)

  129. New: Applying user constraints before prolongation in MGTransferPrebuilt.
    (Julian Roth and Conrad Clevenger, 2020/06/05)

  130. New: FEEvaluation::evaluate(), FEEvaluation::integrate(), FEFaceEvaluation::evaluate() and FEFaceEvaluation::integrate() now take an argument of type EvaluationFlags::EvaluationFlags to determine which of the values, gradients or hessians should be evaluated to quadrature points or integrated, allowing much more expressive programs than the previous list of bools. The evaluation flags can be combined with operator|, similarly to UpdateFlags for FEValues.
    (Timo Heister, 2020/06/05)

  131. Changed: The vertices in CellData are now stored in form of a std::vector instead of C-style array.
    (Peter Munch, 2020/05/31)

  132. Improved: The efficiency of the assembly of step-62 has been improved and now it is 7 times faster.
    (Daniel Garcia-Sanchez, 2020/05/31)

  133. Fixed: Fix a bug where only one CUDAWrappers::MatrixFree object was valid at a given time. There is now a variable CUDAWrappers::mf_n_concurrent_objects in base/cuda_size.h that controls the maximum number of concurrent objects. The default value is five.
    (Bruno Turcksin, 2020/05/29)

  134. New: Add multigrid transfer operators for distributed polynomial and global coarsening.
    (Peter Munch, Laura Prieto Saavedra, 2020/05/29)

  135. Improved: step-28 now uses tasks instead of threads.
    (David Wells, 2020/05/28)

  136. New: The class Particles::DataOut can now output particle properties as scalars, vectors, or tensors, depending on the arguments handed over to the Particles::DataOut::build_patches() function.
    (Rene Gassmoeller, 2020/05/27)

  137. New: When executing a task on a separate thread, if that task ends with throwing an exception instead of returing a value, then this exception will be obtained when you wait for the task using Threads::Task::join() or Threads::Task::return_value().
    (Wolfgang Bangerth, 2020/05/27)

  138. New: GridTools::Cache::get_locally_owned_cell_bounding_boxes_rtree() extracts a tree of bounding boxes covering the locally owned cells of a triangulation. This can be used in conjunction with GridTools::Cache::get_covering_rtree() to make approximate geometrical queries on who owns what spatial region.
    (Luca Heltai, 2020/05/26)

  139. New: pack_rtree_of_indices() and IndexableGetterFromIndices allow to construct an RTree object that stores indices to existing containers of indexable objects.
    (Luca Heltai, 2020/05/24)

  140. New: The class ParticleHandler now provides a signal 'signals.particle_lost' that is triggered whenever a particles can not be associated with a cell while calling its function sort_particles_into_subdomains_and_cells().
    (Rene Gassmoeller, 2020/05/25)

  141. Bugfix: hp::Refinement::choose_p_over_h() now works in parallel.
    (Marc Fehling, 2020/05/22)

  142. New: There is now a second overload for Particles::ParticleAccessor::set_properties() that takes an ArrayView as argument.
    (Wolfgang Bangerth, 2020/05/22)

  143. Removed: All headers under base/std_cxx11/ have been removed.
    (David Wells, 2020/05/21)

  144. Changed: In many other classes that are templated on dim and spacedim, the second template argument spacedim had a default value equal to dim. Particles::DataOut did not, but now does.
    (Wolfgang Bangerth, 2020/05/21)

  145. New: A new BoundingBoxDataOut class is available, to output a collection of objects that can be converted to BoundingBox objects in graphical format.
    (Luca Heltai, 2020/05/19)