Hello everyone!

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

#15455: add mailmap entry (proposed by tamiko) 
https://github.com/dealii/dealii/pull/15455

#15454: Advertise NonlinearSolverSelector in step-77. (proposed by bangerth) 
https://github.com/dealii/dealii/pull/15454

#15452: Fix invalid data access in MatrixFreeTools::compute_diagonal (proposed 
by kronbichler; merged) https://github.com/dealii/dealii/pull/15452

#15451: Fix invalid memory access of DoFAccessorImplementation (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/15451

#15450: NOX: catch std::runtime_error instead of char* for Trilinos 4.2.0 
onwards (proposed by tamiko) https://github.com/dealii/dealii/pull/15450

#15449: Test numerics/nonlinear_solver_selector_03: use 
check_solver_within_range macro (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/15449

#15448: Test cgal/cgal_surface_mesh_02: disable floating point exceptions 
(proposed by tamiko; merged) https://github.com/dealii/dealii/pull/15448

#15447: Test base/hdf5_0{3,5}.mpirun={1,4}: do not compare test output 
(proposed by tamiko; merged) https://github.com/dealii/dealii/pull/15447

#15446: lac/parpack_solver: add missing compress() operation (proposed by 
tamiko; merged) https://github.com/dealii/dealii/pull/15446

#15445: TriaIterator: return a proper Accessor temporary (proposed by tamiko) 
https://github.com/dealii/dealii/pull/15445

#15444: matrix_free/tools.h: avoid stack use after scope (proposed by tamiko) 
https://github.com/dealii/dealii/pull/15444

#15443: [Post-9.5] Add an assertion. (proposed by bangerth) 
https://github.com/dealii/dealii/pull/15443

#15442: fix step-57 bilinear form (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/15442

#15441: MFTools::categorize_by_boundary_ids: use iterator (proposed by 
peterrum; merged) https://github.com/dealii/dealii/pull/15441

#15438: [Post-9.5] Simplify some code that uses SolutionTransfer. (proposed by 
bangerth) https://github.com/dealii/dealii/pull/15438

#15437: Fix step-33. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/15437

#15436: Warn about the use of higher order output when using Visit. (proposed 
by bangerth; merged) https://github.com/dealii/dealii/pull/15436

#15435: Add a better error message for Cuda + bundled Kokkos. (proposed by 
drwells; merged) https://github.com/dealii/dealii/pull/15435

#15434: Examples 9.5 (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/15434

#15431: Fix bug in AffineConstraints::make_sorted_row_list (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/15431

#15430: Fix bug in MatrixFree setup for FE_Nothing (proposed by kronbichler; 
merged) https://github.com/dealii/dealii/pull/15430

#15429: CGAL: fix some bogus warnings with gcc-13 (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/15429

#15428: fe/fe_values: avoid a "maybe uninitialized" warning with gcc-13 
(proposed by tamiko; merged) https://github.com/dealii/dealii/pull/15428

#15425: CMake: avoid adding ${DEAL_II_BUNDLED_INCLUDE_DIRS} to bundled targets 
(proposed by tamiko; merged) https://github.com/dealii/dealii/pull/15425

#15423: Fix a few more 'set up' (proposed by kronbichler; merged) 
https://github.com/dealii/dealii/pull/15423

#15422: Fix clang-tidy complaints (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/15422

#15420: [Post-9.5] Add a version of step-67 that uses PETSc TS time stepping. 
(proposed by bangerth) https://github.com/dealii/dealii/pull/15420

#15419: [Post-9.5] Minor adjustment to versions of step-77 in the test suite. 
(proposed by bangerth) https://github.com/dealii/dealii/pull/15419

#15418: [Post-9.5] When we know that sparsity pattern entries are sorted, 
communicate that. (proposed by bangerth) 
https://github.com/dealii/dealii/pull/15418

#15417: [Post-9.5] Standardize on the idiom of calling std::erase after 
std::unique. (proposed by bangerth) https://github.com/dealii/dealii/pull/15417

#15416: [Post-9.5] Rename a lambda function and make it easier to read. 
(proposed by bangerth) https://github.com/dealii/dealii/pull/15416

#15415: FE_Hermite objects for solving with Hermite finite elements (proposed 
by ivweber) https://github.com/dealii/dealii/pull/15415

#15414: Fix doxygen reflinks (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/15414

#15413: Move source/matrix_free up in build order (proposed by kronbichler; 
merged) https://github.com/dealii/dealii/pull/15413

#15412: Spell 'set up' when used as a verb (proposed by kronbichler; merged) 
https://github.com/dealii/dealii/pull/15412

#15411: Testsuite: symengine/symengine_tensor_operations_04: fix test 
compilation (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/15411

#15410: Discuss replacing KINSOL by SNES or NOX in step-77. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/15410

#15409: Fix a typo in the name of a function in the documentation. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/15409

#15408: Minor adjustment to step-77. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/15408

#15407: Correct a version number. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/15407

#15406: Testsuite: symengine/symengine_tensor_operations_04: fix test 
compilation (proposed by tamiko) https://github.com/dealii/dealii/pull/15406

#15405: Fix some more tests without hypre and with C++20 (proposed by 
masterleinad; merged) https://github.com/dealii/dealii/pull/15405

#15404: Testsuite: sharedtria/communicate_active_fe_indices_01b: do not compare 
test output (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/15404

#15403: Testsuite: scalapack/scalapack_05: add output variant (proposed by 
tamiko; merged) https://github.com/dealii/dealii/pull/15403

#15402: [Post-9.5] Optimize IndexSet::add_indices() for the case of duplicate 
indices. (proposed by bangerth) https://github.com/dealii/dealii/pull/15402

#15401: [Post-9.5] Address some cppcheck findings (proposed by masterleinad) 
https://github.com/dealii/dealii/pull/15401

#15399: Testsuite: do not compare output for some rpe/* tests (proposed by 
tamiko; merged) https://github.com/dealii/dealii/pull/15399

#15397: Testsuite: opencascade/stl_(refinement|write): do not compare output 
(proposed by tamiko; merged) https://github.com/dealii/dealii/pull/15397

#15396: Testsuite: numerics/nonlinear_solver_selector_03_petsc: add output 
variant (proposed by tamiko; merged) https://github.com/dealii/dealii/pull/15396

#15394: Testsuite: mpi/hp_cell_weights_* do not compare output for metis 
variants (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/15394

#15393: Fix poor doxygen indentation choices. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/15393

#15392: add an entry in doc/news/changes/minor for PR #15377 (proposed by 
taojinllnl; merged) https://github.com/dealii/dealii/pull/15392

#15391: Fix ArborX tests for Trilinos 14/Kokkos 4 (proposed by masterleinad; 
merged) https://github.com/dealii/dealii/pull/15391

#15390: Try to work around an Intel compiler issue. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/15390

#15389: Testsuite: metis/metis_*: only run tests, do not compare output 
(proposed by tamiko; merged) https://github.com/dealii/dealii/pull/15389

#15388: Testsuite: fix gmsh tests (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/15388

#15387: Instantiate MGTwoLevelTransferBase explicitly (proposed by 
masterleinad; merged) https://github.com/dealii/dealii/pull/15387

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

#15385: Release preparation: update gitattributes (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/15385

#15384: Release preparation: update copyright years (proposed by tamiko; 
merged) https://github.com/dealii/dealii/pull/15384

#15381: MatrixFree: Only set up the inner faces when so requested (proposed by 
kronbichler) https://github.com/dealii/dealii/pull/15381

#15380: Make FE_EVAL_FACTORY_DEGREE_MAX more robust (proposed by kronbichler; 
merged) https://github.com/dealii/dealii/pull/15380

#15379: Restrict GridTools::Cache tests using Zoltan (proposed by masterleinad; 
merged) https://github.com/dealii/dealii/pull/15379

#15378: fix: update ninja build resource (proposed by emmanuel-ferdman; merged) 
https://github.com/dealii/dealii/pull/15378

#15377: Remove error output in lapack_full_matrix.cc (proposed by taojinllnl; 
merged) https://github.com/dealii/dealii/pull/15377

#15376: Performance tests: small cleanup and documentation update (proposed by 
tamiko; merged) https://github.com/dealii/dealii/pull/15376

#15374: Fix a typo in step-19 (proposed by kronbichler; merged) 
https://github.com/dealii/dealii/pull/15374

#15373: Fix doxygen for PETScWrappers::TimeStepper using DEAL_II_CXX20_REQUIRES 
(proposed by masterleinad; merged) https://github.com/dealii/dealii/pull/15373

#15372: Wait for communication to finish. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/15372

#15370: Add a test for step-70. (proposed by bangerth) 
https://github.com/dealii/dealii/pull/15370

#15369: improve name and documentation (proposed by jh66637; merged) 
https://github.com/dealii/dealii/pull/15369

#15368: PETSc: Fix backward compatibility (proposed by stefanozampini; merged) 
https://github.com/dealii/dealii/pull/15368

#15367: [Post-9.5] Only run expensive parallel code if a vector is really 
parallel. (proposed by bangerth) https://github.com/dealii/dealii/pull/15367

#15366: Avoid a quadratic bottleneck in AffineConstraints::distribute(). 
(proposed by bangerth; merged) https://github.com/dealii/dealii/pull/15366

#15365: Some updates to the step-19 documentation. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/15365

#15364: NonNestedTransfer: allow to pass coarse DH with more dofs than fine DH 
(proposed by jh66637; merged) https://github.com/dealii/dealii/pull/15364

#15362: Use a delegating constructor in DSP. (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/15362

#15360: Update tests (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/15360

#15359: Convert some more places to 'subobject' instead of 'quad'. (proposed by 
drwells; merged) https://github.com/dealii/dealii/pull/15359

#15358: Reuse NonMatching::MappingInfo (proposed by bergbauer; merged) 
https://github.com/dealii/dealii/pull/15358

#15357: make another AdditionalData ctor explicit (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/15357

#15356: Clarify why n_faces() is only possible on cells. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/15356

#15355: Fix compiling deal.II with PETSc and complex scalar type (proposed by 
masterleinad; merged) https://github.com/dealii/dealii/pull/15355

#15354: doc: add info to distort_random (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/15354

#15353: Fix unused-but-set-variable warning (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/15353

#15351: Fix matrix_free_device tests for Trilinos 12.14.1 (proposed by 
masterleinad; merged) https://github.com/dealii/dealii/pull/15351

#15350: Adjust the discussion about solvers in step-6. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/15350

#15349: PETSc tests: Add alternative output files for clang-16 (proposed by 
masterleinad; merged) https://github.com/dealii/dealii/pull/15349

#15348: Make sure a conversion is safe. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/15348

#15347: Enforce callback return value standard for the new 
NonlinearSolverSelector class. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/15347

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

#15345: Extend documentation of the results section of step-59 (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/15345

#15344: PETSc: Convert PetscScalar* iterators when calling 
IndexSet::add_indices (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/15344

#15343: FEFaceEvaluation: Consistently use n_components_ template argument 
(proposed by bergbauer; merged) https://github.com/dealii/dealii/pull/15343

#15342: FEFaceEvaluation: Select general path for exterior cells with 
constraints (proposed by bergbauer; merged) 
https://github.com/dealii/dealii/pull/15342

#15341: Step-69: fix typo in documentation (proposed by mschreter; merged) 
https://github.com/dealii/dealii/pull/15341

#15340: Fix MG p-transfer with FE_Nothing (proposed by sebproell; merged) 
https://github.com/dealii/dealii/pull/15340

#15339: Minor adjustments to FETools::extrapolate(). (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/15339

#15338: Clarify the name of a variable. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/15338

#15336: Fix renumbering in FEPointEvaluation (proposed by jh66637; merged) 
https://github.com/dealii/dealii/pull/15336

#15329: Add something about postprocessing to step-4. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/15329

#15327: github-actions: Do not treat `tautological-constant-compare` as error. 
(proposed by marcfehling; merged) https://github.com/dealii/dealii/pull/15327

#15303: Tensor product evaluation at arbitrary points: Optimize linear case 
(proposed by kronbichler; merged) https://github.com/dealii/dealii/pull/15303

#15297: Choose to initialize BlockVector with ghost elements using 
reinit(partitioners). (proposed by marcfehling; merged) 
https://github.com/dealii/dealii/pull/15297

#15286: Deprecate our own CUDA backend (proposed by Rombur; merged) 
https://github.com/dealii/dealii/pull/15286

#15276: recoverable SNES and TS (proposed by stefanozampini; merged) 
https://github.com/dealii/dealii/pull/15276

#15160: NonlinearSolverSelector class implementation (proposed by singima; 
merged) https://github.com/dealii/dealii/pull/15160

#15007: Fix copy constructor of MappingQ (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/15007

#14978: Move OrthogonalizationStrategy into new file (proposed by peterrum; 
merged) https://github.com/dealii/dealii/pull/14978

#14955: Remove specialization of CellwiseInverseMassMatrixImplBasic::run() 
(proposed by peterrum; merged) https://github.com/dealii/dealii/pull/14955


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

#15453: Make step-70 more robust. (opened) 
https://github.com/dealii/dealii/issues/15453

#15440: Binding to TriaAccessor reference returned by dereferencing a 
TriaIterator temporary leads to use after scope (opened) 
https://github.com/dealii/dealii/issues/15440

#15439: Simplex: out of bounds vector access in DoFAccessor::distribute_dofs() 
(opened and closed) https://github.com/dealii/dealii/issues/15439

#15433: step-57 stalls (opened and closed) 
https://github.com/dealii/dealii/issues/15433

#15432: Bundled Kokkos + CUDA (opened and closed) 
https://github.com/dealii/dealii/issues/15432

#15427: AffineConstraints: out of bounds vector access (opened and closed) 
https://github.com/dealii/dealii/issues/15427

#15426: Matrix-free: out of bounds vector access (opened and closed) 
https://github.com/dealii/dealii/issues/15426

#15424: Failing PETSc tests with older versions (opened) 
https://github.com/dealii/dealii/issues/15424

#15421: Can't visualize step-67 output (opened and closed) 
https://github.com/dealii/dealii/issues/15421

#15400: Improve IndexSet::add_indices() for sorted ranges with duplicates 
(opened) https://github.com/dealii/dealii/issues/15400

#15398: Check for hits in IndexSet::add (opened) 
https://github.com/dealii/dealii/issues/15398

#15395: Testsuite: tests should not output and compare initial and final 
residuals (opened) https://github.com/dealii/dealii/issues/15395

#15383: deal.II Release 9.5.0 (opened) 
https://github.com/dealii/dealii/issues/15383

#15382: Cannot build master with either Intel18 or Intel19 (on stampede2) 
(opened and closed) https://github.com/dealii/dealii/issues/15382

#15375: Improve some AffineConstraints functions. (opened) 
https://github.com/dealii/dealii/issues/15375

#15371: Improve step-70 regarding time step size (opened) 
https://github.com/dealii/dealii/issues/15371

#15363: Remove error output from lapack_full_matrix.cc (opened and closed) 
https://github.com/dealii/dealii/issues/15363

#15361: SNES should throw an exception when it fails to converge (opened) 
https://github.com/dealii/dealii/issues/15361

#15352: Hard-to-understand error messages for simplex triangulation (opened) 
https://github.com/dealii/dealii/issues/15352

#15337: Fast path of FEPointEvaluation for FEDG_Q with n_components>1 broken 
(closed) https://github.com/dealii/dealii/issues/15337

#15309: Talk about actually doing something with the solution computed in 
tutorials (closed) https://github.com/dealii/dealii/issues/15309

#15305: Fields are not reset during MappingInfo().reinit_*() (closed) 
https://github.com/dealii/dealii/issues/15305

#15234: Documentation not showing up correctly - issue with 
DEAL_II_CXX20_REQUIRES (closed) https://github.com/dealii/dealii/issues/15234

#15045: tests/petsc/petsc_partitioner_06.mpirun=4.debug fails (closed) 
https://github.com/dealii/dealii/issues/15045

#14859: Failed assertion with hanging nodes and solution transfer (closed) 
https://github.com/dealii/dealii/issues/14859

#14844: Step-70 runtime error (closed) 
https://github.com/dealii/dealii/issues/14844

#14217: Undefined references  when linking with ld.lld (closed) 
https://github.com/dealii/dealii/issues/14217

#14129: Warning when compiling TableHandler (closed) 
https://github.com/dealii/dealii/issues/14129

#14127: compute_local_to_global_vertex_index_map does not wait for 
communication to finish (closed) https://github.com/dealii/dealii/issues/14127

#14106: Robustness of FEEvaluation's pre-compiled evaluation routines (closed) 
https://github.com/dealii/dealii/issues/14106

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

#12374: CMake: use import and interface targets (closed) 
https://github.com/dealii/dealii/issues/12374

#11529: Ubuntu/Debian: Document better how to use the deal.II package (closed) 
https://github.com/dealii/dealii/issues/11529

#10945: step-19: Revise discussion about time stepping + update movie (closed) 
https://github.com/dealii/dealii/issues/10945

#10939: [step-59] Extend section on possibilities for extensions (closed) 
https://github.com/dealii/dealii/issues/10939

#10175: Bug on find_active_cell_around_point for p::d::t. (closed) 
https://github.com/dealii/dealii/issues/10175

#3230: more quick tests (closed) https://github.com/dealii/dealii/issues/3230

#1333: automated performance tester (closed) 
https://github.com/dealii/dealii/issues/1333


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/6495c1e6.050a0220.8e8ad.1569SMTPIN_ADDED_MISSING%40gmr-mx.google.com.

Reply via email to