Hello everyone!

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

#13548: Fix docu of PreconditionChebyshev regarding degree (proposed by 
peterrum) https://github.com/dealii/dealii/pull/13548

#13547: Add RPE::all_points_found() and ::valid_point_masks() (proposed by 
peterrum) https://github.com/dealii/dealii/pull/13547

#13546: Add Multigrid::set_edge_in_matrix() (proposed by peterrum) 
https://github.com/dealii/dealii/pull/13546

#13545: Make doxygen show correct header file for GridTools::Cache (proposed by 
masterleinad; merged) https://github.com/dealii/dealii/pull/13545

#13543: remove notes on indentation from documentation (proposed by nfehn) 
https://github.com/dealii/dealii/pull/13543

#13542: Fix typo (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/13542

#13541: Add ScalarType as template parameter to MeshWorker::CopyData (proposed 
by jppelteret) https://github.com/dealii/dealii/pull/13541

#13540: Add asserts to MGTwoLevelTransfer (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/13540

#13539: MGTransferGlobalCoarsening::initialize_dof_vector() skip zeroing 
(proposed by peterrum; merged) https://github.com/dealii/dealii/pull/13539

#13538: Fix test for nearest query for ArborXWrappers::DistributedTree 
(proposed by Rombur) https://github.com/dealii/dealii/pull/13538

#13537: Add type promotion to vectorization math operations (proposed by 
jppelteret) https://github.com/dealii/dealii/pull/13537

#13536: Nodal renumbering (proposed by drwells) 
https://github.com/dealii/dealii/pull/13536

#13535: Change one GitHub Workflow CI check to use C++20 (proposed by 
masterleinad) https://github.com/dealii/dealii/pull/13535

#13534: Fix typo in issue_template.md (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/13534

#13533: MGTwoLevelTransfer: remove fine-vector specialization for DG (proposed 
by peterrum; merged) https://github.com/dealii/dealii/pull/13533

#13530: Introduce DEAL_II_VERSION_LTE (proposed by peterrum) 
https://github.com/dealii/dealii/pull/13530

#13529: Implement MGLevelObject::n_levels() (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/13529

#13528: Compute DoFInfo::hanging_node_constraint_masks_comp once (proposed by 
peterrum; merged) https://github.com/dealii/dealii/pull/13528

#13527: Reserve internal container with correct size. (proposed by marcfehling; 
merged) https://github.com/dealii/dealii/pull/13527

#13526: Enable `sc_init` again. (proposed by marcfehling; merged) 
https://github.com/dealii/dealii/pull/13526

#13525: Refine MGTwoLevelTransfer::enable_inplace_operations_if_possible() 
(proposed by peterrum; merged) https://github.com/dealii/dealii/pull/13525

#13524: MatrixFree: fix typo assert message (proposed by mschreter; merged) 
https://github.com/dealii/dealii/pull/13524

#13523: update changelog entry (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/13523

#13521: Revert most of "Avoid implicit bool conversions" (proposed by drwells) 
https://github.com/dealii/dealii/pull/13521

#13520: Refactor constraint application of MGTwoLevelTransfer (proposed by 
peterrum; merged) https://github.com/dealii/dealii/pull/13520

#13519: Introduce internal::MatrixFreeFunctions::ConstraintInfo (proposed by 
peterrum; merged) https://github.com/dealii/dealii/pull/13519

#13518: Remove specialization in MGTwoLevelTransfer::interpolate() (proposed by 
peterrum; merged) https://github.com/dealii/dealii/pull/13518

#13515: Minor updates to the constant modes documentation. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/13515

#13514: Specifying material IDs on Gmsh imports (proposed by singima; merged) 
https://github.com/dealii/dealii/pull/13514

#13513: Test extract constant modes 04 (proposed by gfcas) 
https://github.com/dealii/dealii/pull/13513

#13512: Update constant_modes doc (proposed by gfcas) 
https://github.com/dealii/dealii/pull/13512

#13511: Removed outdated comment. (proposed by marcfehling; merged) 
https://github.com/dealii/dealii/pull/13511

#13508: GitHub-CI: test CPP17 (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/13508

#13507: Use get_communicator() (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/13507

#13506: Check during MF::reinit() if AffineConstraints are closed (proposed by 
peterrum; merged) https://github.com/dealii/dealii/pull/13506

#13505: Add AffineConstraints::is_closed() (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/13505

#13504: Remove a note. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/13504

#13503: Fix std_cxx17::get (proposed by peterrum) 
https://github.com/dealii/dealii/pull/13503

#13502: boost::get -> std_cxx17::get (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/13502

#13499: Use fast hanging node algorithm for polynomial global coarsening 
(proposed by peterrum; merged) https://github.com/dealii/dealii/pull/13499

#13498: GC: allow to pass in external partitioner (proposed by peterrum; 
merged) https://github.com/dealii/dealii/pull/13498

#13497: Add std_cxx17::variant. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/13497

#13496: Implement ReferenceCell::point_is_inside. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/13496

#13495: Minor doc adjustments. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/13495

#13494: GC: enable inplace operation for coarse side (proposed by peterrum; 
merged) https://github.com/dealii/dealii/pull/13494

#13493: ComputeIndexOwner: allow to use map instead of vector (proposed by 
peterrum; merged) https://github.com/dealii/dealii/pull/13493

#13492: Optimize broadcast for natively-supported MPI types (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/13492

#13490: affine_constraints: hide another block of forward declarations 
(proposed by marcfehling; merged) https://github.com/dealii/dealii/pull/13490

#13489: Added `n_nonzero_elements` to PETSc `BlockSparseMatrix`. (proposed by 
marcfehling; merged) https://github.com/dealii/dealii/pull/13489

#13488: Removing DEAL_II_MPI_CONST_CAST (proposed by pengfej; merged) 
https://github.com/dealii/dealii/pull/13488

#13487: Fix bugs in ComputeIndexOwner::Dictionary and CellIDTranslator 
(proposed by peterrum; merged) https://github.com/dealii/dealii/pull/13487

#13486: fix a test (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/13486

#13485: Annotate more code gallery source files. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/13485

#13484: Extend docu of MatrixFree::initialize_dof_vector() (proposed by 
peterrum; merged) https://github.com/dealii/dealii/pull/13484

#13483: MPI 3: minor edits (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/13483

#13481: clarify docu of MatrixFree::initialize_dof_vector() (proposed by nfehn; 
merged) https://github.com/dealii/dealii/pull/13481

#13479: Simplify logic in RepartitioningPolicyTools::FirstChildPolicy (proposed 
by peterrum; merged) https://github.com/dealii/dealii/pull/13479

#13478: Move p:d:T::has_hanging_nodes() to DistributedTriangulationBase 
(proposed by peterrum; merged) https://github.com/dealii/dealii/pull/13478

#13473: Provide a template variable that can be used to query whether T is a 
natively supported MPI type. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/13473

#13472: Deal gracefully with replicating an empty array. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/13472

#13471: Use a valid communicator. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/13471

#13467: Run quick tests in GitHub Linux CI (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/13467

#13438: Support SUNDIALS 6.0 and later. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/13438

#13409: Performance tests: add a valgrind wrapper (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/13409

#13395: Introduce a template variable mpi_type_id_for_type. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/13395

#13310: Speed up evaluation of RefSpaceFEFieldFunction (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/13310

#13181: Extend MeshWorker::ScratchData to support hp (proposed by jppelteret; 
merged) https://github.com/dealii/dealii/pull/13181

#12617: MatrixFree: store refinement configuration once per cell (proposed by 
peterrum; merged) https://github.com/dealii/dealii/pull/12617

#11871: MGLevelGlobalTransfer/MGTransferMatrixFree: allow user to init vectors 
(proposed by peterrum; merged) https://github.com/dealii/dealii/pull/11871


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

#13544: Docu shows wrong header file for GridTools::Cache (opened and closed) 
https://github.com/dealii/dealii/issues/13544

#13532: Shift "coding conventions" to Wiki? (opened) 
https://github.com/dealii/dealii/issues/13532

#13531: Why does "coding conventions" contain information on "indentation"? 
(opened) https://github.com/dealii/dealii/issues/13531

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

#13517: Why does FEPointEvaluation::EvaluatorTypeTraits use Number and not 
Tensor<0, dim, Number>? (opened) https://github.com/dealii/dealii/issues/13517

#13516: Should functionality such as 
triangulation.contains_point/face/cell(point/face/cell) be implemented in 
deal.II? (opened) https://github.com/dealii/dealii/issues/13516

#13510: For load balancing, should cells have a "base weight" or not? (opened) 
https://github.com/dealii/dealii/issues/13510

#13509: doxygen: Simplex tags move functions from namespace (opened) 
https://github.com/dealii/dealii/issues/13509

#13501: Robustness problem with RemotePointEvaluation (opened) 
https://github.com/dealii/dealii/issues/13501

#13500: Rethink whether RemotePointEvaluation should live in namespace MPI 
(opened) https://github.com/dealii/dealii/issues/13500

#13491: `TrilinosWrappers::BlockSparseMatrix` can only be block-symmetric? 
(opened) https://github.com/dealii/dealii/issues/13491

#13480: Does MatrixFree::initialize_dof_vector() set vector entries to zero? 
(closed) https://github.com/dealii/dealii/issues/13480

#13474: Remove DEAL_II_MPI_CONST_CAST (closed) 
https://github.com/dealii/dealii/issues/13474

#13469: invalid communicator in 
tests/fullydistributed_grids/repartitioning_05.cc (closed) 
https://github.com/dealii/dealii/issues/13469

#13460: failure in tests/base/aligned_vector_replicate_04.cc (closed) 
https://github.com/dealii/dealii/issues/13460

#13447: drop MPI 2.x support (closed) 
https://github.com/dealii/dealii/issues/13447

#13377: Thoughts about the interface to query MPI data types? (closed) 
https://github.com/dealii/dealii/issues/13377

#13242: Cannot find the header files when compiling with WSL Linux distributive 
in VS code (closed) https://github.com/dealii/dealii/issues/13242

#13171: Extend MeshWorker::ScratchData to support hp (closed) 
https://github.com/dealii/dealii/issues/13171

#11955: Optimize Utilities::MPI::broadcast() (closed) 
https://github.com/dealii/dealii/issues/11955


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/62335b34.1c69fb81.b5375.1b08SMTPIN_ADDED_MISSING%40gmr-mx.google.com.

Reply via email to