Hello everyone!

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

#13482: Deprecate Utilities::MPI::create_group (proposed by masterleinad) 
https://github.com/dealii/dealii/pull/13482

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

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

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

#13476: Avoid integer comparison warning. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/13476

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

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

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

#13470: Check MPI error codes. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/13470

#13468: quick_tests/affinity: fix warning (proposed by marcfehling) 
https://github.com/dealii/dealii/pull/13468

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

#13466: Fix the TBB quick test. (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/13466

#13465: Remove MPI 2.x logic (proposed by pengfej) 
https://github.com/dealii/dealii/pull/13465

#13464: documentation: MPI 3.0 minimum (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/13464

#13463: Minor update to FE_Nedelec. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/13463

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

#13461: CMake: require MPI 3.0 (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/13461

#13459: Fix GC tests (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/13459

#13458: [CI] run all MPI tests on Jenkins (proposed by tjhei) 
https://github.com/dealii/dealii/pull/13458

#13457: Improve asserts in parallel::distributed::SolutionTransfer (proposed by 
peterrum) https://github.com/dealii/dealii/pull/13457

#13455: add test for invert_cells_with_negative_measure (proposed by tjhei; 
merged) https://github.com/dealii/dealii/pull/13455

#13454: add changelog for gmsh inverted cell fix (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/13454

#13453: Avoid a warning about comparison of differently sized integers. 
(proposed by bangerth; merged) https://github.com/dealii/dealii/pull/13453

#13452: Provide a second error for Trilinos sparsity pattern problems. 
(proposed by bangerth; merged) https://github.com/dealii/dealii/pull/13452

#13451: cell_weight: remove initial weight from distributed applications. 
(proposed by marcfehling) https://github.com/dealii/dealii/pull/13451

#13450: Fix instantiation for add_entries_local_to_global (proposed by 
zjiaqi2018; merged) https://github.com/dealii/dealii/pull/13450

#13449: cell_weight: not implemented for partition_zorder (proposed by 
marcfehling; merged) https://github.com/dealii/dealii/pull/13449

#13448: Add an assertion for p4est weights. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/13448

#13446: Simplify MPI IO in parallel vtu output (proposed by pengfej; merged) 
https://github.com/dealii/dealii/pull/13446

#13445: Error out with too large Trilinos sparsity patterns. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/13445

#13444: Allow loading Gmsh files with some cells inverted (proposed by singima; 
merged) https://github.com/dealii/dealii/pull/13444

#13443: Add assert to MFTools::compute_diagonal() (proposed by peterrum; 
merged) https://github.com/dealii/dealii/pull/13443

#13442: Minor updates to ARKode in-code commentary. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/13442

#13441: Fix run time error in step-75: initialize diagonal vector (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/13441

#13439: Declare a number of static consts as constexpr (proposed by tamiko; 
merged) https://github.com/dealii/dealii/pull/13439

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

#13437: Replace present_index by index() in DoFAccessor (proposed by 
rezarastak; merged) https://github.com/dealii/dealii/pull/13437

#13436: Move a couple of functions out of line. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/13436

#13427: Add shape function illustrations for FE_Nedelec (proposed by harmonj; 
merged) https://github.com/dealii/dealii/pull/13427

#13416: Fix non matching coupling (proposed by luca-heltai; merged) 
https://github.com/dealii/dealii/pull/13416

#13394: Add ArborXWrappers::DistributedTree (proposed by Rombur; merged) 
https://github.com/dealii/dealii/pull/13394


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

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

#13477: Quicktests fail with Intel oneAPI suite. (opened) 
https://github.com/dealii/dealii/issues/13477

#13475: Remove Utilities::MPI::create_group() (opened) 
https://github.com/dealii/dealii/issues/13475

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

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

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

#13456: No test failure for wrong output (opened and closed) 
https://github.com/dealii/dealii/issues/13456

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

#13440: Step-75 broken (opened and closed) 
https://github.com/dealii/dealii/issues/13440

#13428: Failure when building Trilinos matrices with more than 2B entries 
(closed) https://github.com/dealii/dealii/issues/13428

#13412: Buggy constraints in `NonMatching` namespace (closed) 
https://github.com/dealii/dealii/issues/13412

#13347: GMSH quad mesh with some cells with negative weight (closed) 
https://github.com/dealii/dealii/issues/13347

#9901: tbb::task is deprecated (closed) 
https://github.com/dealii/dealii/issues/9901

#3201: Crash with a trivial mesh from gMsh   (closed) 
https://github.com/dealii/dealii/issues/3201


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/621fa2b5.1c69fb81.10064.77c6SMTPIN_ADDED_MISSING%40gmr-mx.google.com.

Reply via email to