deal.II Newsletter #215

14 views
Skip to first unread message

Rene Gassmoeller

unread,
Jun 15, 2022, 6:01:23 AM6/15/22
to dea...@googlegroups.com

Hello everyone!

This is deal.II newsletter #215.
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:

#13976: Fix generalized support points of FE_RaviartThomasNodal (proposed by kronbichler)
#13975: Fix the MPI window functions with clang. (proposed by drwells; merged)
#13974: CMake: Use default Kokkos' DefaultNodeType in Tpetra test (proposed by tamiko; merged)
#13973: CMake: Use deal.II's global index type in Tpetra compatibility test (proposed by tamiko; merged)
#13971: Remove remaining @author (proposed by peterrum; merged)
#13969: CMake: use full compiler/linker flags for trilinos sanity checks (proposed by tamiko; merged)
#13968: Run codespell (proposed by drwells; merged)
#13967: Explicitly template function pointwise_definiteness(..) (proposed by simonsticko; merged)
#13964: contrib/python_bindings: set PYTHON_EXECUTABLE (proposed by tamiko; merged)
#13963: CMake: Use -Wno-pass-failed for clang (proposed by tamiko; merged)
#13962: Support HDF5 output with one rank having no cells (proposed by tjhei)
#13961: Fix more PETSc complex tests (proposed by kronbichler; merged)
#13960: Fix two tests with complex PETSc (proposed by kronbichler; merged)
#13959: test cgal/cgal_surface_mesh_01: add output variant (proposed by tamiko; merged)
#13958: precondition.h: switch from Assert to AssertThrow (proposed by peterrum; merged)
#13956: test cgal/cgal_surface_mesh_01: Update output (proposed by tamiko; merged)
#13955: CGAL: fix header includes (proposed by tamiko; merged)
#13954: GridGenerator: put CGAL implementation into own compilation unit (proposed by tamiko; merged)
#13953: Replace 2*dim (proposed by peterrum; merged)
#13952: MatrixFree: Fix element-centric loops with different cell geometry compression (proposed by kronbichler; merged)
#13951: MatrixFree: Simplify some code in initialization of DoF indices (proposed by kronbichler)
#13950: CMake: use -Wno-misleading-indentation for grid_generator.cc compilation unit (proposed by tamiko; merged)
#13947: DoFAccessor: Run process_dof_indices only on FE entities with DoFs (proposed by kronbichler)
#13946: Simplify access to number of raw objects (proposed by kronbichler)
#13945: Fix TriaAccessor::is_ghost_on_level for case without MPI (proposed by kronbichler; merged)
#13944: slepc/solver_04: adjust tolerances (proposed by tamiko; merged)
#13943: test mpi/p4est_bug_01: Update test. (proposed by tamiko)
#13941: test ginkgo/solver: adjust tolerances (proposed by tamiko; merged)
#13940: tests cgal/* add output variants (proposed by tamiko; merged)
#13939: test distributed_grids/large_vtu_01: fix test (proposed by tamiko; merged)
#13938: test distributed_grids/3d_refinement_09: refactor test and add an output variant (proposed by tamiko; merged)
#13937: test base/unsubscribe_subscriptor: add output variant (proposed by tamiko)
#13936: test algorithms/general_data_storage_01: add output variant (proposed by tamiko)
#13935: Fix some test typenames for GCC-12. (proposed by drwells; merged)
#13934: Arkode linear jacobians (proposed by drwells; merged)
#13933: Fix some CGAL tests. (proposed by drwells; merged)
#13932: Move implementation of implicit_function() into .cc file (proposed by fdrmrc; merged)
#13931: Use pre-compiled structdim for access to TriaObjects in Accessor (proposed by kronbichler)
#13930: Speed up computation of cell vertex indices cache (proposed by kronbichler)
#13929: Move wrappers for CGAL points into header (proposed by fdrmrc; merged)
#13928: Move implicit_function() in CGALWrappers namespace (proposed by fdrmrc)
#13927: CMake: add DEAL_II_CGAL_HAS_DEPRECATED_BOOST_INCLUDES check (proposed by tamiko; merged)
#13925: base/polynomials_bdm.cc: avoid a compiler warning with gcc-12 (proposed by tamiko; merged)
#13924: Provide internal function for faster access of 3D cell->line_index (proposed by kronbichler)
#13923: Avoid saving and setting refinement flags in distributed Tria (proposed by kronbichler)
#13922: Speed up evaluation of some ReferenceCell operations (proposed by kronbichler)
#13921: Use shortcut when determining isotropic refinement cases (proposed by kronbichler)
#13920: Try to fix valence (proposed by peterrum; merged)
#13919: Make fields private (proposed by peterrum; merged)
#13918: More sundials 6 2 (proposed by drwells; merged)
#13917: ParameterHandler::print_parameters(): Fix demangle alias parameter JSON (proposed by mschreter; merged)
#13916: VT::interpolate_boundary_values() for pyramids and wedges (proposed by peterrum; merged)
#13915: MF: make things more consistent (proposed by peterrum; merged)
#13914: Fix compiler warning (proposed by NiklasWik; merged)
#13913: Fix input and output of some cgal tests. (proposed by luca-heltai; merged)
#13912: Fix orientation issue with hex cells. (proposed by luca-heltai; merged)
#13911: Work on warning (proposed by peterrum; merged)
#13909: Remove lex_faces from matrix-free kernels (proposed by peterrum; merged)
#13908: Rename fe_base.h to fe_data.h (proposed by peterrum; merged)
#13907: Add typename and instantiation to `project_boundary_values_div_conforming` (proposed by NiklasWik; merged)
#13906: Doc/fix update flags h (proposed by saitoasukakawaii; merged)
#13905: Dealii 9.3 (proposed by saitoasukakawaii)
#13904: Replace variadic arguments with AdditionalData struct (proposed by fdrmrc; merged)
#13903: Update sundials docs (proposed by drwells; merged)
#13902: Cleanup sundials context (proposed by drwells; merged)
#13901: Add missing header to test (proposed by kronbichler; merged)
#13900: Fix step-77 by fixing KINSOL. (proposed by drwells; merged)
#13899: Document possibility for data locality in matrix-free tutorial (proposed by kronbichler; merged)
#13898: Remove inclusion of additional headers (proposed by kronbichler; merged)
#13897: Work on two compile warnings with Clang-14 (proposed by kronbichler; merged)
#13896: Fix compilation with CGAL. (proposed by drwells; merged)
#13895: Use free consensus algorithms functions instead of the class version. (proposed by bangerth)
#13894: Avoid unicode and correct 10-5 -> 10^-5. (proposed by bangerth; merged)
#13893: Fix arkode 3 and 4 (proposed by drwells; merged)
#13892: Fix step-81 complex number warnings (proposed by zjiaqi2018; merged)
#13891: Optimize computation of Nedelec shape functions. (proposed by bangerth)
#13888: Qualify int*_t and uint*_t with std::. (proposed by bangerth; merged)
#13887: doxygen: don't use @ingroup simplex (proposed by tjhei; merged)
#13885: Fix a problem with combining MPI::LargeCount and PETSc. (proposed by drwells; merged)
#13884: Use map::find rather than insert to avoid creating temporary (proposed by kronbichler; merged)
#13883: Remove another inclusion of hanging_nodes_internal.h. Documentation. (proposed by kronbichler; merged)
#13879: add large vtu test (proposed by tjhei; merged)
#13867: LargeCount MPI_write/read_at for p::fd:Tria (proposed by zjiaqi2018; merged)
#13850: wrapcomments.py update (proposed by tjhei; merged)
#13846: Restore compatibility with OpenCASCADE >= 7.6.0 (proposed by marcfehling; merged)
#13835: Implement class NonMatching::MappingInfo (proposed by bergbauer; merged)
#13828: Simplify access to MG DoFs in DoFAccessor (proposed by kronbichler; merged)
#13771: CGAL: Add remesh_surface utility (proposed by fdrmrc; merged)
#13767: Create a Triangulation<3> from a Triangulation<2,3> (proposed by fdrmrc; merged)
#13753: Variadic template parameter for CGAL Mesh criteria (proposed by fdrmrc; merged)
#13743: Cgal dealii tria from implicit function (proposed by luca-heltai; merged)
#13457: Allow to average values in parallel::distributed::SolutionTransfer (proposed by peterrum; merged)
#13158: Add get_embedding_dofs() to FE_Nedelec (2-D) (proposed by harmonj; merged)
#10747: Add parallel test for find_active_cell_around_point (proposed by dangars; merged)

And this is a list of recently opened or closed discussions:

#13977 block_info for hp enabled DoFHandler (opened)
#13972 Compatibility with Tpetra in Trilinos 13.4.0 / 13.2.0 (opened)
#13970 Should `ParameterHandler::add_parameter()` execute the action? (opened)
#13966 Missing explicit instantiations of dealii::NonMatching::internal::QuadratureGeneratorImplementation::pointwise_definiteness<1> (opened and closed)
#13965 Assertion in AlignedVector<T>::Deleter::MPISharedMemDeleterAction::delete_arry with libc++ (opened and closed)
#13957 Some comments on the type constraint of `PreconditionRelaxation::step` (opened and closed)
#13949 Optimize compilation units and object libraries: investigate sizes, minimize includes, minimize compilation times, enforce DAG (opened)
#13948 MappingFEField does not support hessian (opened)
#13942 matrix_free/ecl_01: fails with different l2 norm (opened and closed)
#13926 gcc-11/12: Bogus warnings emitted notifying about disabled misleading indentation warning (opened and closed)
#13910 Fix compile warnings (opened)
#13890 Warning in step-81 (opened and closed)
#13881 Unity build is broken (closed)
#13822 Compilation fails for opencascade 7.6.1 (closed)
#13640 Deprecated boost header (closed)
#13522 Compilation error with clang-5 (closed)
#13318 Compatibility with opencascade 7.6.0 (closed)
#13166 We are not yet compatible with SUNDIALS 6.0 (closed)
#12594 Step-77: compatibility issues and no convergence (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.

Reply all
Reply to author
Forward
0 new messages