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) https://github.com/dealii/dealii/pull/13976

#13975: Fix the MPI window functions with clang. (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/13975

#13974: CMake: Use default Kokkos' DefaultNodeType in Tpetra test (proposed by 
tamiko; merged) https://github.com/dealii/dealii/pull/13974

#13973: CMake: Use deal.II's global index type in Tpetra compatibility test 
(proposed by tamiko; merged) https://github.com/dealii/dealii/pull/13973

#13971: Remove remaining @author (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/13971

#13969: CMake: use full compiler/linker flags for trilinos sanity checks 
(proposed by tamiko; merged) https://github.com/dealii/dealii/pull/13969

#13968: Run codespell (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/13968

#13967: Explicitly template function pointwise_definiteness(..) (proposed by 
simonsticko; merged) https://github.com/dealii/dealii/pull/13967

#13964: contrib/python_bindings: set PYTHON_EXECUTABLE (proposed by tamiko; 
merged) https://github.com/dealii/dealii/pull/13964

#13963: CMake: Use -Wno-pass-failed for clang (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/13963

#13962: Support HDF5 output with one rank having no cells (proposed by tjhei) 
https://github.com/dealii/dealii/pull/13962

#13961: Fix more PETSc complex tests (proposed by kronbichler; merged) 
https://github.com/dealii/dealii/pull/13961

#13960: Fix two tests with complex PETSc (proposed by kronbichler; merged) 
https://github.com/dealii/dealii/pull/13960

#13959: test cgal/cgal_surface_mesh_01: add output variant (proposed by tamiko; 
merged) https://github.com/dealii/dealii/pull/13959

#13958: precondition.h: switch from Assert to AssertThrow (proposed by 
peterrum; merged) https://github.com/dealii/dealii/pull/13958

#13956: test cgal/cgal_surface_mesh_01: Update output (proposed by tamiko; 
merged) https://github.com/dealii/dealii/pull/13956

#13955: CGAL: fix header includes (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/13955

#13954: GridGenerator: put CGAL implementation into own compilation unit 
(proposed by tamiko; merged) https://github.com/dealii/dealii/pull/13954

#13953: Replace 2*dim (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/13953

#13952: MatrixFree: Fix element-centric loops with different cell geometry 
compression (proposed by kronbichler; merged) 
https://github.com/dealii/dealii/pull/13952

#13951: MatrixFree: Simplify some code in initialization of DoF indices 
(proposed by kronbichler) https://github.com/dealii/dealii/pull/13951

#13950: CMake: use -Wno-misleading-indentation for grid_generator.cc 
compilation unit (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/13950

#13947: DoFAccessor: Run process_dof_indices only on FE entities with DoFs 
(proposed by kronbichler) https://github.com/dealii/dealii/pull/13947

#13946: Simplify access to number of raw objects (proposed by kronbichler) 
https://github.com/dealii/dealii/pull/13946

#13945: Fix TriaAccessor::is_ghost_on_level for case without MPI (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/13945

#13944: slepc/solver_04: adjust tolerances (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/13944

#13943: test mpi/p4est_bug_01: Update test. (proposed by tamiko) 
https://github.com/dealii/dealii/pull/13943

#13941: test ginkgo/solver: adjust tolerances (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/13941

#13940: tests cgal/* add output variants (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/13940

#13939: test distributed_grids/large_vtu_01: fix test (proposed by tamiko; 
merged) https://github.com/dealii/dealii/pull/13939

#13938: test distributed_grids/3d_refinement_09: refactor test and add an 
output variant (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/13938

#13937: test base/unsubscribe_subscriptor: add output variant (proposed by 
tamiko) https://github.com/dealii/dealii/pull/13937

#13936: test algorithms/general_data_storage_01: add output variant (proposed 
by tamiko) https://github.com/dealii/dealii/pull/13936

#13935: Fix some test typenames for GCC-12. (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/13935

#13934: Arkode linear jacobians (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/13934

#13933: Fix some CGAL tests. (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/13933

#13932: Move implementation of implicit_function() into .cc file (proposed by 
fdrmrc; merged) https://github.com/dealii/dealii/pull/13932

#13931: Use pre-compiled structdim for access to TriaObjects in Accessor 
(proposed by kronbichler) https://github.com/dealii/dealii/pull/13931

#13930: Speed up computation of cell vertex indices cache (proposed by 
kronbichler) https://github.com/dealii/dealii/pull/13930

#13929: Move wrappers for CGAL points into header (proposed by fdrmrc; merged) 
https://github.com/dealii/dealii/pull/13929

#13928: Move implicit_function() in CGALWrappers namespace (proposed by fdrmrc) 
https://github.com/dealii/dealii/pull/13928

#13927: CMake: add DEAL_II_CGAL_HAS_DEPRECATED_BOOST_INCLUDES check (proposed 
by tamiko; merged) https://github.com/dealii/dealii/pull/13927

#13925: base/polynomials_bdm.cc: avoid a compiler warning with gcc-12 (proposed 
by tamiko; merged) https://github.com/dealii/dealii/pull/13925

#13924: Provide internal function for faster access of 3D cell->line_index 
(proposed by kronbichler) https://github.com/dealii/dealii/pull/13924

#13923: Avoid saving and setting refinement flags in distributed Tria (proposed 
by kronbichler) https://github.com/dealii/dealii/pull/13923

#13922: Speed up evaluation of some ReferenceCell operations (proposed by 
kronbichler) https://github.com/dealii/dealii/pull/13922

#13921: Use shortcut when determining isotropic refinement cases (proposed by 
kronbichler) https://github.com/dealii/dealii/pull/13921

#13920: Try to fix valence (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/13920

#13919: Make fields private (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/13919

#13918: More sundials 6 2 (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/13918

#13917: ParameterHandler::print_parameters(): Fix demangle alias parameter JSON 
 (proposed by mschreter; merged) https://github.com/dealii/dealii/pull/13917

#13916: VT::interpolate_boundary_values() for pyramids and wedges (proposed by 
peterrum; merged) https://github.com/dealii/dealii/pull/13916

#13915: MF: make things more consistent (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/13915

#13914: Fix compiler warning (proposed by NiklasWik; merged) 
https://github.com/dealii/dealii/pull/13914

#13913: Fix input and output of some cgal tests. (proposed by luca-heltai; 
merged) https://github.com/dealii/dealii/pull/13913

#13912: Fix orientation issue with hex cells. (proposed by luca-heltai; merged) 
https://github.com/dealii/dealii/pull/13912

#13911: Work on warning (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/13911

#13909: Remove lex_faces from matrix-free kernels (proposed by peterrum; 
merged) https://github.com/dealii/dealii/pull/13909

#13908: Rename fe_base.h to fe_data.h (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/13908

#13907: Add typename and instantiation to 
`project_boundary_values_div_conforming` (proposed by NiklasWik; merged) 
https://github.com/dealii/dealii/pull/13907

#13906: Doc/fix update flags h (proposed by saitoasukakawaii; merged) 
https://github.com/dealii/dealii/pull/13906

#13905: Dealii 9.3 (proposed by saitoasukakawaii) 
https://github.com/dealii/dealii/pull/13905

#13904: Replace variadic arguments with AdditionalData struct (proposed by 
fdrmrc; merged) https://github.com/dealii/dealii/pull/13904

#13903: Update sundials docs (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/13903

#13902: Cleanup sundials context (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/13902

#13901: Add missing header to test (proposed by kronbichler; merged) 
https://github.com/dealii/dealii/pull/13901

#13900: Fix step-77 by fixing KINSOL. (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/13900

#13899: Document possibility for data locality in matrix-free tutorial 
(proposed by kronbichler; merged) https://github.com/dealii/dealii/pull/13899

#13898: Remove inclusion of additional headers (proposed by kronbichler; 
merged) https://github.com/dealii/dealii/pull/13898

#13897: Work on two compile warnings with Clang-14 (proposed by kronbichler; 
merged) https://github.com/dealii/dealii/pull/13897

#13896: Fix compilation with CGAL. (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/13896

#13895: Use free consensus algorithms functions instead of the class version. 
(proposed by bangerth) https://github.com/dealii/dealii/pull/13895

#13894: Avoid unicode and correct 10-5 -> 10^-5. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/13894

#13893: Fix arkode 3 and 4 (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/13893

#13892: Fix step-81 complex number warnings (proposed by zjiaqi2018; merged) 
https://github.com/dealii/dealii/pull/13892

#13891: Optimize computation of Nedelec shape functions. (proposed by bangerth) 
https://github.com/dealii/dealii/pull/13891

#13888: Qualify int*_t and uint*_t with std::. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/13888

#13887: doxygen: don't use @ingroup simplex (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/13887

#13885: Fix a problem with combining MPI::LargeCount and PETSc. (proposed by 
drwells; merged) https://github.com/dealii/dealii/pull/13885

#13884: Use map::find rather than insert to avoid creating temporary (proposed 
by kronbichler; merged) https://github.com/dealii/dealii/pull/13884

#13883: Remove another inclusion of hanging_nodes_internal.h. Documentation. 
(proposed by kronbichler; merged) https://github.com/dealii/dealii/pull/13883

#13879: add large vtu test (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/13879

#13867: LargeCount MPI_write/read_at for p::fd:Tria (proposed by zjiaqi2018; 
merged) https://github.com/dealii/dealii/pull/13867

#13850: wrapcomments.py update (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/13850

#13846: Restore compatibility with OpenCASCADE >= 7.6.0 (proposed by 
marcfehling; merged) https://github.com/dealii/dealii/pull/13846

#13835: Implement class NonMatching::MappingInfo (proposed by bergbauer; 
merged) https://github.com/dealii/dealii/pull/13835

#13828: Simplify access to MG DoFs in DoFAccessor (proposed by kronbichler; 
merged) https://github.com/dealii/dealii/pull/13828

#13771: CGAL: Add remesh_surface utility (proposed by fdrmrc; merged) 
https://github.com/dealii/dealii/pull/13771

#13767: Create a Triangulation<3> from a Triangulation<2,3> (proposed by 
fdrmrc; merged) https://github.com/dealii/dealii/pull/13767

#13753: Variadic template parameter for CGAL Mesh criteria (proposed by fdrmrc; 
merged) https://github.com/dealii/dealii/pull/13753

#13743: Cgal dealii tria from implicit function (proposed by luca-heltai; 
merged) https://github.com/dealii/dealii/pull/13743

#13457: Allow to average values in parallel::distributed::SolutionTransfer 
(proposed by peterrum; merged) https://github.com/dealii/dealii/pull/13457

#13158: Add get_embedding_dofs() to FE_Nedelec (2-D) (proposed by harmonj; 
merged) https://github.com/dealii/dealii/pull/13158

#10747: Add parallel test for find_active_cell_around_point (proposed by 
dangars; merged) https://github.com/dealii/dealii/pull/10747


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

#13977: block_info for hp enabled DoFHandler (opened) 
https://github.com/dealii/dealii/issues/13977

#13972: Compatibility with Tpetra in Trilinos 13.4.0 / 13.2.0 (opened) 
https://github.com/dealii/dealii/issues/13972

#13970: Should `ParameterHandler::add_parameter()` execute the action? (opened) 
https://github.com/dealii/dealii/issues/13970

#13966: Missing explicit instantiations of 
dealii::NonMatching::internal::QuadratureGeneratorImplementation::pointwise_definiteness<1>
 (opened and closed) https://github.com/dealii/dealii/issues/13966

#13965: Assertion in 
AlignedVector<T>::Deleter::MPISharedMemDeleterAction::delete_arry with libc++ 
(opened and closed) https://github.com/dealii/dealii/issues/13965

#13957: Some comments on the type constraint of `PreconditionRelaxation::step` 
(opened and closed) https://github.com/dealii/dealii/issues/13957

#13949: Optimize compilation units and object libraries: investigate sizes, 
minimize includes, minimize compilation times, enforce DAG (opened) 
https://github.com/dealii/dealii/issues/13949

#13948: MappingFEField does not support hessian (opened) 
https://github.com/dealii/dealii/issues/13948

#13942: matrix_free/ecl_01: fails with different l2 norm (opened and closed) 
https://github.com/dealii/dealii/issues/13942

#13926: gcc-11/12: Bogus warnings emitted notifying about disabled misleading 
indentation warning (opened and closed) 
https://github.com/dealii/dealii/issues/13926

#13910: Fix compile warnings (opened) 
https://github.com/dealii/dealii/issues/13910

#13890: Warning in step-81 (opened and closed) 
https://github.com/dealii/dealii/issues/13890

#13881: Unity build is broken (closed) 
https://github.com/dealii/dealii/issues/13881

#13822: Compilation fails for opencascade 7.6.1 (closed) 
https://github.com/dealii/dealii/issues/13822

#13640: Deprecated boost header (closed) 
https://github.com/dealii/dealii/issues/13640

#13522: Compilation error with clang-5 (closed) 
https://github.com/dealii/dealii/issues/13522

#13318: Compatibility with opencascade 7.6.0 (closed) 
https://github.com/dealii/dealii/issues/13318

#13166: We are not yet compatible with SUNDIALS 6.0 (closed) 
https://github.com/dealii/dealii/issues/13166

#12594: Step-77: compatibility issues and no convergence (closed) 
https://github.com/dealii/dealii/issues/12594


A list of all major changes since the last release can be found at 
https://www.dealii.org/developer/doxygen/deal.II/recent_changes.html.


Thanks for being part of the community!


Let us know about questions, problems, bugs or just share your experience by 
writing to dealii@googlegroups.com, or by opening issues or pull requests at 
https://www.github.com/dealii/dealii.
Additional information can be found at https://www.dealii.org/.

-- 
The deal.II project is located at http://www.dealii.org/
For mailing list/forum options, see 
https://groups.google.com/d/forum/dealii?hl=en
--- 
You received this message because you are subscribed to the Google Groups 
"deal.II User Group" group.
To unsubscribe from this group and stop receiving emails from it, send an email 
to dealii+unsubscr...@googlegroups.com.
To view this discussion on the web visit 
https://groups.google.com/d/msgid/dealii/62a9adf1.1c69fb81.3a26c.d643SMTPIN_ADDED_MISSING%40gmr-mx.google.com.

Reply via email to