Hello everyone!

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

#11449: Convert step-2 to a simplex test (proposed by peterrum) 
https://github.com/dealii/dealii/pull/11449

#11448: Added test for FENothing and FEQ constraints. (proposed by marcfehling) 
https://github.com/dealii/dealii/pull/11448

#11447: Utility grid generator function `hyper_line` for tests. (proposed by 
marcfehling) https://github.com/dealii/dealii/pull/11447

#11446: Update grid/cell_id_08 output. (proposed by marcfehling) 
https://github.com/dealii/dealii/pull/11446

#11445: Minor change to CellWeights exception handling. (proposed by 
marcfehling) https://github.com/dealii/dealii/pull/11445

#11444: Refactor the HDF5 abort code. (proposed by drwells) 
https://github.com/dealii/dealii/pull/11444

#11443: Make sure every particle always has a property pool associated with it. 
(proposed by bangerth) https://github.com/dealii/dealii/pull/11443

#11442: Make a test more verbose. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/11442

#11441: Avoid warning about unused variable in particle.h (proposed by 
masterleinad; merged) https://github.com/dealii/dealii/pull/11441

#11440: Avoid MPI calls in the HDF5 destructors when there is an exception - 
DataSet (proposed by dangars; merged) 
https://github.com/dealii/dealii/pull/11440

#11439: Fix warning due to boost (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/11439

#11438: Fix boost include file. (proposed by luca-heltai; merged) 
https://github.com/dealii/dealii/pull/11438

#11437: Clean up FE_Nothing::get_name(). (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/11437

#11436: Add test for geometric global-coarsening multigrid (proposed by 
peterrum; merged) https://github.com/dealii/dealii/pull/11436

#11434: Rename file in test folder (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/11434

#11433: Add test for p-multigrid (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/11433

#11432: MatrixFreeTools::compute_diagonal() make class const (proposed by 
peterrum; merged) https://github.com/dealii/dealii/pull/11432

#11431: CMake: Fix Ginkgo linkage (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/11431

#11430: Better document FE_Nothing. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/11430

#11429: Generalize MGTwoLevelTransfer for simplex meshes (proposed by peterrum) 
https://github.com/dealii/dealii/pull/11429

#11428: FETools::get_projection_matrix for simplices (proposed by peterrum) 
https://github.com/dealii/dealii/pull/11428

#11427: Fix tests with output files with same name (proposed by peterrum; 
merged) https://github.com/dealii/dealii/pull/11427

#11426: Add utility functions to ReferenceCell namespace (proposed by peterrum; 
merged) https://github.com/dealii/dealii/pull/11426

#11425: Fix output of grid/cell_id_08 (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/11425

#11424: Introduce ReferenceCell::compute_orientation and 
::permute_according_orientation (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/11424

#11423: Introduce ReferenceCell::unit_tangential_vectors() (proposed by 
peterrum; merged) https://github.com/dealii/dealii/pull/11423

#11422: Work on compute_embedding_matrices() for simplex (proposed by peterrum) 
https://github.com/dealii/dealii/pull/11422

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

#11420: Test alternative path in QProjector (proposed by peterrum) 
https://github.com/dealii/dealii/pull/11420

#11419: Pyramid/wedge: diverse fixes (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/11419

#11418: step-27: Updated to new interface. (proposed by marcfehling) 
https://github.com/dealii/dealii/pull/11418

#11417: CI: remove unnecessary OSX setup steps (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/11417

#11416: Simplex/pyramid/wedge: add DG test (proposed by peterrum) 
https://github.com/dealii/dealii/pull/11416

#11415: Ignore deprecated-volatile warning when disabling exta diagnostic 
(proposed by Rombur) https://github.com/dealii/dealii/pull/11415

#11414: Raviart-Thomas orientation and permutation issue (proposed by konsim83) 
https://github.com/dealii/dealii/pull/11414

#11413: Ginkgo Updates - 2nd try (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/11413

#11412: Silence unused parameter warning when building with C++17 (proposed by 
masterleinad; merged) https://github.com/dealii/dealii/pull/11412

#11411: make constructors of Table and AlignedVector explicit (proposed by 
tjhei; merged) https://github.com/dealii/dealii/pull/11411

#11410: Revert "Merge pull request #11402 from pratikvn/fix-ginkgo-cmake" 
(proposed by Rombur; merged) https://github.com/dealii/dealii/pull/11410

#11409: Work on MatrixFreeTools::compute_matrix (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/11409

#11408: MatrixFreeTools::compute_diagonal() for simplex grid (proposed by 
peterrum; merged) https://github.com/dealii/dealii/pull/11408

#11407: Remove n_q_points_face from fe_evaluation.h (proposed by peterrum; 
merged) https://github.com/dealii/dealii/pull/11407

#11406: FEFaceValues: use face_no to select quadrature rule (proposed by 
peterrum; merged) https://github.com/dealii/dealii/pull/11406

#11405: Implement FE_WedgeDGP and FE_PyramidDGP (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/11405

#11404: GenericDoFsPerObject: fix formatting (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/11404

#11403: FE_Nothing: pass reference-cell type to constructor (proposed by 
peterrum; merged) https://github.com/dealii/dealii/pull/11403

#11402: Update Ginkgo cmake detection and tests. (proposed by pratikvn; merged) 
https://github.com/dealii/dealii/pull/11402

#11401: MatrixFree: introduce FaceToCellTopology::face_type (proposed by 
peterrum) https://github.com/dealii/dealii/pull/11401

#11400: Use QCollection within MapptingInfo::initialize (proposed by peterrum) 
https://github.com/dealii/dealii/pull/11400

#11399: Remove compatibility code for GCC versions prior to 5.0. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/11399

#11398: Clarify a comment in class Particle. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/11398

#11397: Do not inspect an object that has been moved from. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/11397

#11396: Store reference to QuadratureDescriptor in FEEvaluationBaseData 
(proposed by peterrum; merged) https://github.com/dealii/dealii/pull/11396

#11395: Introduce SUNDIALS N_Vector module (proposed by sebproell) 
https://github.com/dealii/dealii/pull/11395

#11394: Simplify constructor of FEEvaluationBaseData (proposed by peterrum; 
merged) https://github.com/dealii/dealii/pull/11394

#11393: Added missing libraries to Ginkgo linking (proposed by nabw) 
https://github.com/dealii/dealii/pull/11393

#11392: Better document serialization functions. (proposed by bangerth) 
https://github.com/dealii/dealii/pull/11392

#11391: Prepare for storing particle locations in the PropertyPool. (proposed 
by bangerth; merged) https://github.com/dealii/dealii/pull/11391

#11390: Let Particle::get_(reference_)location() return by-value rather than 
reference (proposed by bangerth) https://github.com/dealii/dealii/pull/11390

#11389: GridGenerator::convert_hypercube_to_simplex_mesh(): manifold_id in 2D 
(proposed by eliasstudiert) https://github.com/dealii/dealii/pull/11389

#11388: Allow read access to data in Interpolated*Function (proposed by tjhei) 
https://github.com/dealii/dealii/pull/11388

#11387: MappingInfo: convert quadrature to face-quadrature rules (proposed by 
peterrum) https://github.com/dealii/dealii/pull/11387

#11386: Added missing header for boost 1.75.0. (proposed by marcfehling; 
merged) https://github.com/dealii/dealii/pull/11386

#11385: CI: fix OSX cmake version 3.18 (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/11385

#11384: CMake-3.19 fixes (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/11384

#11383: Add a filter=output attribute to output files (proposed by tamiko) 
https://github.com/dealii/dealii/pull/11383

#11381: provide memory_consumption() for some Function* classes (proposed by 
tjhei; merged) https://github.com/dealii/dealii/pull/11381

#11378: Link in the correct figure. (proposed by bangerth) 
https://github.com/dealii/dealii/pull/11378

#11377: Fix some typos regarding 'hexahedra' (proposed by kronbichler; merged) 
https://github.com/dealii/dealii/pull/11377

#11376: Clean up std::map usage in interpolate_boundary_values (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/11376

#11374: Add a particle test. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/11374

#11373: Add to the documentation of numbers::signaling_nan(). (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/11373

#11372: Generalize ShapeInfo::reinit (proposed by peterrum) 
https://github.com/dealii/dealii/pull/11372

#11370: Use function from simplex_grids.h (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/11370

#11368: Remove temporary string objects in Utilities::(un)pack. (proposed by 
marcfehling; merged) https://github.com/dealii/dealii/pull/11368

#11367: Add missing versions of VectorTools::interpolate_boundary_values for 
hp::MappingCollection (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/11367

#11365: Added Triangulation::create_cell_iterator(). (proposed by marcfehling; 
merged) https://github.com/dealii/dealii/pull/11365

#11364: Added getter function for child_indices of CellId + CellId benchmark 
testcase (proposed by marcfehling; merged) 
https://github.com/dealii/dealii/pull/11364

#11363: Rename some member functions of PropertyPool, also member variables of 
Particle (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/11363

#11361: Enable FEFaceValues for wedges and pyramids (proposed by peterrum; 
merged) https://github.com/dealii/dealii/pull/11361

#11339: Avoid MPI calls in the HDF5 destructors when there is an exception 
(proposed by dangars; merged) https://github.com/dealii/dealii/pull/11339

#11278: SUNDIALS: update ARKode to version 5.4.0 (proposed by sebproell; 
merged) https://github.com/dealii/dealii/pull/11278

#11259: Added instantiation for cases when dim < spacedim (proposed by 
malhartidke; merged) https://github.com/dealii/dealii/pull/11259

#11216: Consistency in using hp concatenation symbols. (proposed by 
marcfehling; merged) https://github.com/dealii/dealii/pull/11216

#11201: Add GridGenerator::convert_hypercube_to_simplex_mesh (proposed by 
eliasstudiert; merged) https://github.com/dealii/dealii/pull/11201

#10764: Assign faces different quadrature rules (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/10764


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

#11450: Handling of auxiliary vectors in matrix-free loops (opened) 
https://github.com/dealii/dealii/issues/11450

#11435: SUNDIALS interface. (opened) 
https://github.com/dealii/dealii/issues/11435

#11382: [CI] OSX on Github Actions fails (opened and closed) 
https://github.com/dealii/dealii/issues/11382

#11380: SUNDIALS: replace copy with N_Vector module (opened) 
https://github.com/dealii/dealii/issues/11380

#11379: boost 1.75.0 incompatibilty (opened and closed) 
https://github.com/dealii/dealii/issues/11379

#11375: Compress test output files? (opened and closed) 
https://github.com/dealii/dealii/issues/11375

#11362: CellId::get_cell() should have been a member function of the 
Triangulation class (closed) https://github.com/dealii/dealii/issues/11362

#11272: ENABLE_IF_SUPPORTED macro is incompatible with cmake-3.19 (closed) 
https://github.com/dealii/dealii/issues/11272

#10008: Compilation failure with current development version of ginkgo (closed) 
https://github.com/dealii/dealii/issues/10008


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/5fee03d2.1c69fb81.52adb.a65eSMTPIN_ADDED_MISSING%40gmr-mx.google.com.

Reply via email to