Hello everyone!

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

#13711: Fix the nodal renumbering tests. (proposed by drwells) 
https://github.com/dealii/dealii/pull/13711

#13710: Restrict feinterface/stokes test (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/13710

#13709: Add two asserts in NonMatching::MeshClassifier. (proposed by 
simonsticko; merged) https://github.com/dealii/dealii/pull/13709

#13708: Add white space to fix exception message split over several lines. 
(proposed by simonsticko; merged) https://github.com/dealii/dealii/pull/13708

#13707: Add more tests. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/13707

#13706: Add ReferenceCell::get_midpoint_quadrature(). (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/13706

#13705: Create coarse mesh out of a CGAL::Surface_mesh (proposed by fdrmrc) 
https://github.com/dealii/dealii/pull/13705

#13704: SolverFlexibleCG: Slightly improve documentation (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/13704

#13702: Adjust test output for new FE_RaviartThomasNodal (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/13702

#13701: Fix test failure: Close the right AffineConstraints object (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/13701

#13700: Correctly size CellData::vertices in GridTools. (proposed by drwells; 
merged) https://github.com/dealii/dealii/pull/13700

#13699: Skip default values in get_coarse_mesh_description(). (proposed by 
drwells; merged) https://github.com/dealii/dealii/pull/13699

#13698: Add a data-locality-optimized iteration scheme to SolverCG (proposed by 
kronbichler) https://github.com/dealii/dealii/pull/13698

#13697: Add changelog for MappingQ (proposed by kronbichler; merged) 
https://github.com/dealii/dealii/pull/13697

#13696: Add GenericDoFsPerObject::generate() (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/13696

#13695: Fix format of table (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/13695

#13694: Generalize do_interpolate_boundary_values() for pyramid and wedge 
(proposed by peterrum) https://github.com/dealii/dealii/pull/13694

#13693: unit_support_points and unit_face_support_points for wedges and 
pyramids (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/13693

#13692: Implement ReferenceCell::face_to_cell_lines() for pyramids and wedges 
(proposed by peterrum; merged) https://github.com/dealii/dealii/pull/13692

#13691: Rename some face batches (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/13691

#13690: Improve asserts in MF/FEEval regarding FENothing (proposed by peterrum; 
merged) https://github.com/dealii/dealii/pull/13690

#13689: Test that exposes bug in Triangulation::create_triangulation (proposed 
by luca-heltai) https://github.com/dealii/dealii/pull/13689

#13688: Fix FEEvaluation::gather_evaluate() for user-defined batches (proposed 
by peterrum; merged) https://github.com/dealii/dealii/pull/13688

#13685: Reduce number of instantiations of FEEvaluation template factory 
(proposed by kronbichler; merged) https://github.com/dealii/dealii/pull/13685

#13684: Fix a recently added test (proposed by kronbichler; merged) 
https://github.com/dealii/dealii/pull/13684

#13683: Implement flexible variant of conjugate gradient method (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/13683

#13682: SolverCG: Switch to more common variable names (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/13682

#13681: Add LinearAlgebra::distributed::BlockVector::set_ghost_state() 
(proposed by peterrum; merged) https://github.com/dealii/dealii/pull/13681

#13679: Fix tests. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/13679

#13678: Add ReferenceCell::volume() and ::barycenter(). (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/13678

#13677: Petsc bddc preconditioner (proposed by nabw) 
https://github.com/dealii/dealii/pull/13677

#13676: Use simpler initialization of std::set (proposed by kronbichler; 
merged) https://github.com/dealii/dealii/pull/13676

#13675: Minor edits to the C++ namespace documentation. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/13675

#13674: Use renumbering of DoFs for step-37 benchmark (proposed by kronbichler; 
merged) https://github.com/dealii/dealii/pull/13674

#13673: Upgrade write_vtu_in_parallel based on mpi large IO update (proposed by 
pengfej) https://github.com/dealii/dealii/pull/13673

#13672: Improve tutorial graph (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/13672

#13671: Hanging nodes support for matrix-free RT (proposed by NiklasWik) 
https://github.com/dealii/dealii/pull/13671

#13669: First try at detecting CGAL more robustly. (proposed by luca-heltai; 
merged) https://github.com/dealii/dealii/pull/13669

#13667: Fix some problems with renumbering with no local DoFs (proposed by 
drwells; merged) https://github.com/dealii/dealii/pull/13667

#13666: step-75: added link to external repository. (proposed by marcfehling; 
merged) https://github.com/dealii/dealii/pull/13666

#13665: Modernize c++ header (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/13665

#13664: Cgal surface to deal.II triangulation (proposed by fdrmrc; merged) 
https://github.com/dealii/dealii/pull/13664

#13663: MGConstrainedDoFs::add_boundary_indices() (proposed by zjiaqi2018; 
merged) https://github.com/dealii/dealii/pull/13663

#13661: Cgal triangulation (proposed by luca-heltai; merged) 
https://github.com/dealii/dealii/pull/13661

#13657: Add class NonMatching::FEInterfaceValues (proposed by simonsticko; 
merged) https://github.com/dealii/dealii/pull/13657

#13653: Add CGAL::Surface_mesh support (proposed by fdrmrc; merged) 
https://github.com/dealii/dealii/pull/13653

#13648: Add DataPostprocessors::BoundaryIds. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/13648

#13599: Use 64-bit integer for `n_nonzero_elements`. (proposed by marcfehling; 
merged) https://github.com/dealii/dealii/pull/13599

#13414: Introduce free functions for consensus algorithms. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/13414


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

#13703: List of currently failing tests (opened) 
https://github.com/dealii/dealii/issues/13703

#13687: Behavior of `FEEvaluation::reinit()` (opened) 
https://github.com/dealii/dealii/issues/13687

#13686: MUMPS from Trilinos requires matrix to exist on destruction/ 
reinitialization (opened) https://github.com/dealii/dealii/issues/13686

#13680: Wrong assertion when creating co-dimension one quad grids. (opened) 
https://github.com/dealii/dealii/issues/13680

#13670: Rol::VectorAdaptor::reduce() does not perform parallel reduction 
(opened) https://github.com/dealii/dealii/issues/13670

#13668: Make CGAL detection robust (opened) 
https://github.com/dealii/dealii/issues/13668

#13555: For load balancing, should weights of cells be of type `double`? 
(closed) https://github.com/dealii/dealii/issues/13555

#10989: Import TaskFlow 2.7.0 (closed) 
https://github.com/dealii/dealii/issues/10989

#7723: Implement flexible variant of conjugate gradients (closed) 
https://github.com/dealii/dealii/issues/7723


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/627a8c36.1c69fb81.7e535.f316SMTPIN_ADDED_MISSING%40gmr-mx.google.com.

Reply via email to