Hello everyone!
This is deal.II newsletter #328.
It automatically reports recently merged features and discussions about the deal.II finite element library.
Below you find a list of recently proposed or merged features:
#18840: Provide a bit more context for step-10. (proposed by bangerth)
#18839: Matrix-free faces in 1d: Add forgotten changelogs (proposed by kronbichler; merged)
#18838: Take over changelog file for 9.7.1 from release branch (proposed by kronbichler; merged)
#18837: [9.7 branch] Port #18787 and #18789 to release branch (proposed by kronbichler; merged)
#18836: [9.7 branch] MappingP1: add default constructor (proposed by kronbichler; merged)
#18835: [9.7 branch] Port #18756 and #18763 to 9.7 release branch (proposed by kronbichler; merged)
#18833: [9.7 branch] `FESystem`: update line orientations in 2d. (proposed by drwells; merged)
#18832: `FESystem`: update line orientations in 2d. (proposed by drwells; merged)
#18831: `DoFTools::map_dofs_to_support_points()`: check that duplicates are close. (proposed by drwells; merged)
#18830: Zero out previous content in PolynomialsVectorAnisotropic::evaluate() (proposed by kronbichler; merged)
#18829: Use @param, not @arg, to document function arguments. (proposed by bangerth; merged)
#18828: PolynomialsRT_Bubbles: remove static data members. (proposed by drwells; merged)
#18827: Fix typo in constraints.h documentation (proposed by iXueJie; merged)
#18826: Bump actions/checkout from 4 to 5 (proposed by dependabot[bot]; merged)
#18825: Give a file a proper suffix. (proposed by bangerth; merged)
#18824: `QProjector`: consolidate two tests and the subface projection code. (proposed by drwells; merged)
#18822: github actions: switch from CUDA 11 to CUDA 12 (proposed by tjhei)
#18821: Fix a warning in a test. (proposed by drwells; merged)
#18820: gh-actions: added feature matrix. (proposed by marcfehling)
#18819: gh-actions: Imminent brownout of macos-13. (proposed by marcfehling; merged)
#18818: Improve an error message. (proposed by bangerth; merged)
#18817: When reading parameters from a string, don't say 'from file <input string>'. (proposed by bangerth; merged)
#18816: gh-actions: Also build on windows-2025. (proposed by marcfehling)
#18815: gh-actions: Also build in C++20 mode on macos. (proposed by marcfehling)
#18814: Fix error in step-32 when running dimensions other than 2 (proposed by RyanMoulday; merged)
#18813: Limit a workaround to older clang++ versions. (proposed by bangerth; merged)
#18812: Doc: fix ParameterHandler example (proposed by tjhei; merged)
#18811: Export more BOOST names from boost.graph. (proposed by bangerth; merged)
#18810: Export more BOOST functions. (proposed by bangerth; merged)
#18809: Suppress warnings when compiling backward compatibility headers as modules. (proposed by bangerth; merged)
#18808: Export additional symbols from boost.ccm. (proposed by bangerth; merged)
#18807: Reset FP exception flags at the end of test runs. (proposed by bangerth; merged)
#18806: `ClosestSurfacePoint`: use `ObserverPointer` and some other minor cleanups. (proposed by drwells; merged)
#18805: Add `ReferenceCell::refinement_cases()`. (proposed by drwells; merged)
#18803: [9.7 branch] Fix default for MatrixOut. (proposed by bangerth; merged)
#18802: Fix default for MatrixOut. (proposed by bangerth; merged)
#18801: Use uint8_t instead of unsigned char for geometric_orientation. (proposed by bangerth; merged)
#18799: fix workstream paper citation (proposed by tjhei; merged)
#18798: Vtk5.1 support (proposed by mkghadban; merged)
#18796: remove non-existent Vector forward declarations (proposed by tjhei; merged)
#18795: doxygen: hide TEMPL_* macros (proposed by tjhei; merged)
#18794: doc: SolverGMRES batched_mode (proposed by tjhei; merged)
#18793: Improve documentation of LA::distributed::Vector::print (proposed by Rombur; merged)
#18791: Alias Tpetra classes into the TrilinosWrappers namespace (proposed by masterleinad)
#18790: Remove unnecessary include files in tests (proposed by kronbichler; merged)
#18789: Describe result of #18328 in changelog file (proposed by kronbichler; merged)
#18788: Fix a typo (proposed by kronbichler; merged)
#18787: Fix a few formatting issues in the 9.7 changelog (proposed by kronbichler; merged)
#18786: Make `MappingP1` internal data names more consistent. (proposed by drwells; merged)
#18785: `QProjector`: make the 2d subface code `ReferenceCell`-independent. (proposed by drwells; merged)
#18784: Mappings: refactor the piola gradient. (proposed by drwells; merged)
#18783: Add parameter to control PETSc's timestepper problem type (proposed by fernandezerbes)
#18781: Implement `ReferenceCell::subface_vertex_location()`. (proposed by drwells; merged)
#18780: add DataOutInterface documentation (proposed by tjhei; merged)
#18779: Remove some unnecessary `[[maybe_unused]]`s. (proposed by drwells; merged)
#18777: Update changelogs on the 9.7 branch. (proposed by bangerth; merged)
#18776: Fix another 9.7 changelog. (proposed by drwells; merged)
#18775: Fix another 9.7 changelog. (proposed by drwells; merged)
#18772: fix nvcc work-around in petsc_matrix_base.h (proposed by tjhei; merged)
#18769: Avoid deprecation warning for using a deprecated class in a deprecated function (proposed by masterleinad; merged)
#18767: Fix C++20 modules CI by using CMAKE_CXX_STANDARD=23 (proposed by masterleinad; merged)
#18766: MappingP1: add default constructor (proposed by tjhei; merged)
#18765: Some smaller updates to the 9.7 changelog. (proposed by bangerth; merged)
#18764: Remove the CUDA module. (proposed by drwells; merged)
#18763: Matrix-free face setup in 1d: allow neighbors to differ by more than 1 level (proposed by kronbichler; merged)
#18762: (dealii-9.7) MSVC c++20 compatibility - DoFInvalidAccessor template instantiations (proposed by gsegon; merged)
#18761: MSVC c++20 compatibility - DoFInvalidAccessor template instantiations (proposed by gsegon; merged)
#18760: simplify kokkos device logic (proposed by tjhei; merged)
#18759: Implemented read_partitioned_msh() (proposed by devi-raksha)
#18758: gh-actions: build deal.II on windows with c++20. (proposed by marcfehling; merged)
#18756: Add test for identification of faces in matrix-free framework (proposed by kronbichler; merged)
#18755: Fix: DG+1D+periodic+matrix_free (proposed by peterrum)
#18754: Fix: TpetraWrappers::Vector::locally_owned_elements() returns wrong index set (proposed by kinnewig; merged)
#18753: Fix more modules for external dependencies (proposed by masterleinad; merged)
#18752: Update website URL from www.dealii.org to dealii.org (proposed by tamiko; merged)
#18738: Links for the results sections in the tutorials. (proposed by cembooks; merged)
#18727: Implement back_interpolate() for TpetraWrappers::Vector. (proposed by kinnewig; merged)
#18680: Tools for SBM: ClosestSurfacePoint class (proposed by mwichro; merged)
#18433: Auto-indent Python in pre-commit (proposed by jpthiele; merged)
#18418: Implementation of Portable::FEEvaluation::get/submit_symmetric_gradient (proposed by YiminJin; merged)
And this is a list of recently opened or closed discussions:
#18834 Change auto-generated labels in tutorials. (opened)
#18823 Fix unlinked reference to the removed function `VectorTools::project_boundary_values_curl_conforming` (opened and closed)
#18804 cmake is ignoring my BOOST_DIR (opened)
#18800 Regression tester regressed 14f9f2 (opened)
#18797 Compilation failures with CUDA, boost-1.88.0 and clang-20 (opened)
#18792 AffineConstraints::distribute_local_to_global(Vector, IndexSet, LinearAlgebra::TpetraWrappers::Vector<number>) returns wrong system right hand side.. (opened)
#18782 Call std::breakpoint_if_debugging before aborting a program in failed asserts. (opened)
#18778 Bug in `mesh_loop` in DG with local refinement (opened)
#18774 Avoid 'using' the two-argument Utilities::MPI::ConsensusAlgorithms::Interface::run() function. (opened)
#18773 `CellAccessor<dim, spacedim>` circumvents constness of `Triangulation` (opened)
#18771 Make `FE_Nothing` a first class citizen - i.e., allow the exceptional case of 0 degrees of freedom in a computation and in our linear algebra (opened)
#18770 `Table<N, Number>` reports wrong size when one of the dimensions has size 0 (opened)
#18768 Erroneous deprecation warning in SparseMatrixTools::restrict_to_full_matrices (opened and closed)
#18757 deal.II 9.7.0: dof_accessor.cc does not compile on Visual Studio 2022 with C++20 (opened and closed)
#18729 TpetraWrappers::Vector::locally_owned_elements() returns wrong index set (closed)
#18627 Reference in step-2 (closed)
#18526 Should wrapped external libraries be wrapped in the dealii module, or a different module? (closed)
#18450 CGAL throws exception at program end. (closed)
#18419 Use 'list(APPEND ...)' when collecting header and source files. (closed)
#18372 Auto-indent Python scripts in our CI steps. (closed)
#18145 Should we ban "Merge branch `master` of `https://github.com/dealii/dealii` into `feature-branch`"? (closed)
#18034 Compile warnings with bundled tbb and gcc-14.2 (closed)
#17718 Link-time optimization issues. (closed)
#17122 Gridin (closed)
#16792 linux debug cuda-11 CI failing (closed)
#16289 Assessment of the difficulty in porting CPU architecture for dealii (closed)
#15814 Both 9.5.0 and 9.5.1 failed to install on aarch64 machines (closed)
#13568 Mapping::get_vertices() uses GeometryInfo::vertices_per_cell (closed)
#12441 Add distance_to_unit_cell to ReferenceCell (closed)
#9369 Native smoothing of grids respecting Manifolds (closed)
#8161 Boost 1.70 is not compatible with CUDA (closed)
#5664 Failing opencascade/arclength_boundary_02 (closed)
#4768 Compile tests in tests/fail/ (closed)
A list of all major changes since the last release can be found at this website.
Thanks for being part of the community!
Let us know about questions, problems, bugs or just share your experience by writing to this mailing list, or by opening issues or pull requests on Github.
Additional information can be found at our official website.