From bfb171ae718643c7b3dfc9ba976a9b7d1dfa52a3 Mon Sep 17 00:00:00 2001 From: Wolfgang Bangerth Date: Wed, 11 Sep 2024 09:52:07 -0600 Subject: [PATCH] Finalize release announcements. --- 9.6/announce | 40 ++++++++++++++++++++++++++++++++-------- 9.6/announce-short | 22 +++++++++------------- 2 files changed, 41 insertions(+), 21 deletions(-) diff --git a/9.6/announce b/9.6/announce index 5c3261a..8adfc65 100644 --- a/9.6/announce +++ b/9.6/announce @@ -5,23 +5,47 @@ available for free under an Open Source license from the deal.II homepage at https://www.dealii.org/ The major changes of this release are: + - There are six new tutorial programs, on checkpointing simulations + (step-83), integrating time-dependent solvers with external time + stepping libraries (step-86, using PETSc's TS library), advanced + point evaluation techniques (step-87), non-matching grids + (step-89), and trace-based methods for PDEs on embedded surfaces + (step-90). - Much work has gone into writing wrappers for Trilinos' Tpetra stack of linear algebra classes. Tpetra is Trilinos' Kokkos-based replacement for the now-deprecated Epetra stack. While many things already work with the Tpetra wrappers, not everything that is currently available with the Epetra wrappers is implemented with the Tpetra wrappers at this point. - - Better tet refinement - - Support for hanging nodes in Nedelec-SZ - - FERemoteEvaluation - - Cubic simplex elements - - New tutorials, new code gallery programs - - + - Substantial improvements to the multigrid two-level transfer + operators, including matrix-free based versions and versions for + p-refinement. + - Strategies for better refinement of tetrahedra. + - Support for hanging nodes in the Nedelec-SZ implementation. + - Cubic simplex elements. + - Better and delayed orthogonalization strategies for the GMRES and + F-GMRES implementations. + - A class FERemoteEvaluation that provides support for evaluating + finite element shape functions and solutions on parts of the + domain stored by other MPI processes. + - Tool classes TaskResult and Lazy that provide ways to compute + values on a separate thread or only when first accessed. + - deal.II now requires and uses of C++17. For more information see: - The preprint at https://www.dealii.org/deal96-preprint.pdf - - The list of changes at + - The list of 185 changes listed at https://www.dealii.org/developer/doxygen/deal.II/changes_between_9_5_2_and_9_6_0.html The main features of deal.II are: + - Extensive documentation and 89 working example programs + - Support for dimension-independent programming + - Locally refined adaptive meshes and multigrid support + - A zoo of different finite elements + - Built-in support for shared memory and distributed parallel computing, + scaling from laptops to clusters with 300,000+ of processor cores + - Interfaces to Trilinos, PETSc, SUNDIALS, UMFPACK and many other external + software packages + - Input and output for a wide variety of meshing and visualization platforms. + +The deal.II developers diff --git a/9.6/announce-short b/9.6/announce-short index cbece5e..e176a78 100644 --- a/9.6/announce-short +++ b/9.6/announce-short @@ -1,29 +1,25 @@ -Version 9.5.0 of deal.II, the object-oriented finite element library awarded +Version 9.6.0 of deal.II, the object-oriented finite element library awarded the J. H. Wilkinson Prize for Numerical Software, has been released. It is available for free under an Open Source license from the deal.II homepage at https://www.dealii.org/ The major changes of this release are: - - Substantial updates and extensions to deal.II's interfaces to other - libraries. This includes, in particular, the integration of Kokkos - additions and updates to the PETSc and Trilinos interfaces. - - Improvements to the matrix-free infrastructure - - Better support for non-matching grids - - Faster or more robust linear solvers and preconditioners - - Many changes to the CMake configuration system, as well as more extensive - use of modern C++ features - - A large number of updates to the tutorials and other documentation. + - Six new tutorial programs. + - Much work on wrappers for Trilinos' Tpetra stack of linear algebra classes. + - Improvements to the multigrid two-level transfer operators. + - Better orthogonalization strategies for the GMRES and F-GMRES implementations. + - deal.II now requires and uses of C++17. More information about changes can be found in the release preprint at -https://www.dealii.org/deal95-preprint.pdf. +https://www.dealii.org/deal96-preprint.pdf. The main features of deal.II are: - - Extensive documentation and 83 working example programs + - Extensive documentation and 89 working example programs - Support for dimension-independent programming - Locally refined adaptive meshes and multigrid support - A zoo of different finite elements - Built-in support for shared memory and distributed parallel computing, - scaling from laptops to clusters with 100,000+ of processor cores + scaling from laptops to clusters with 300,000+ of processor cores - Interfaces to Trilinos, PETSc, SUNDIALS, UMFPACK and many other external software packages - Input and output for a wide variety of meshing and visualization platforms. -- 2.39.5