Hello everyone!

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

#15679: Use parallel::apply_to_subranges(). (proposed by bangerth) 
https://github.com/dealii/dealii/pull/15679

#15678: Fix face orientation (proposed by peterrum) 
https://github.com/dealii/dealii/pull/15678

#15677: KINSOL: allow for custom setup (proposed by sebproell) 
https://github.com/dealii/dealii/pull/15677

#15675: Test examples/step-40: avoid std::cout race condition (proposed by 
tamiko; merged) https://github.com/dealii/dealii/pull/15675

#15674: documentation: switch all hyperlinks in the documentation to https:// 
(proposed by tamiko; merged) https://github.com/dealii/dealii/pull/15674

#15673: matrix_free/fe_evaluation.h: avoid a warning with g++-13 (proposed by 
tamiko; merged) https://github.com/dealii/dealii/pull/15673

#15672: Introduce DEAL_II[_DEPRECATED_EARLY]_WITH_COMMENT (proposed by 
masterleinad; merged) https://github.com/dealii/dealii/pull/15672

#15671: Avoid const return type in functions (proposed by masterleinad) 
https://github.com/dealii/dealii/pull/15671

#15670: Tests: update official tester names (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/15670

#15669: [9.5] Use -Werror again in enable_if_supported (proposed by tamiko; 
merged) https://github.com/dealii/dealii/pull/15669

#15668: Remove reference to VectorSpacevector from the documentation. (proposed 
by bangerth; merged) https://github.com/dealii/dealii/pull/15668

#15667: Remove reference to VectorSpaceVector from ReadWriteVector's 
documentation. (proposed by bangerth) 
https://github.com/dealii/dealii/pull/15667

#15666: Remove derivation of LinearAlgebra::distributed::Vector from 
VectorSpaceVector. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/15666

#15665: Update minimum compiler versions for C++17 (proposed by masterleinad; 
merged) https://github.com/dealii/dealii/pull/15665

#15664: Add a missing typedef to the epetra vector wrapper. (proposed by 
drwells; merged) https://github.com/dealii/dealii/pull/15664

#15661: clang-tidy: Enable readability-container-size-empty check (proposed by 
masterleinad) https://github.com/dealii/dealii/pull/15661

#15660: Fix some comparisons operator for g++-13 with C++20 (proposed by 
masterleinad; merged) https://github.com/dealii/dealii/pull/15660

#15658: Add missing include path for `ReadVector` (proposed by mschreter; 
merged) https://github.com/dealii/dealii/pull/15658

#15657: Fix step-46 tutorial program (proposed by kronbichler; merged) 
https://github.com/dealii/dealii/pull/15657

#15656: Tests: grid/mesh_3d.h: add forgotten GridTests::reorder* call (proposed 
by tamiko; merged) https://github.com/dealii/dealii/pull/15656

#15655: github: update indent worker to Ubuntu 22.04 (proposed by tamiko) 
https://github.com/dealii/dealii/pull/15655

#15654: Tests: add forgotten namespace, fix typo in includes (proposed by 
tamiko; merged) https://github.com/dealii/dealii/pull/15654

#15653: enable examples/ tests in quick tests (proposed by tamiko) 
https://github.com/dealii/dealii/pull/15653

#15652: github: update linux runners (proposed by tamiko) 
https://github.com/dealii/dealii/pull/15652

#15651: Tests: if no numdiff executable is found fall back to running tests 
instead of dropping them (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/15651

#15649: Test serialization for serial and shared triangulations (proposed by 
pcafrica) https://github.com/dealii/dealii/pull/15649

#15645: Change step-68 + timing_step-68 to use FEPointEvaluator (proposed by 
blaisb; merged) https://github.com/dealii/dealii/pull/15645

#15644: Quick tests: also run examples/ tests (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/15644

#15642: Test fe/fe_enriched_step-36: make a test less expensive (proposed by 
tamiko; merged) https://github.com/dealii/dealii/pull/15642

#15641: Fix some more clang-tidy findings (proposed by masterleinad) 
https://github.com/dealii/dealii/pull/15641

#15640: Use balanced braces for doxygen formulas. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/15640

#15639: Remove a funny exit path in AffineConstraints::close(). (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/15639

#15637: Create a vector space vector concept. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/15637

#15636: base/exceptions.h: avoid warnings in Trilinos / Kokkos headers 
(proposed by tamiko; merged) https://github.com/dealii/dealii/pull/15636

#15635: FEEvaluation: Use n_lanes class variable (proposed by bergbauer; 
merged) https://github.com/dealii/dealii/pull/15635

#15634: Taskflow for async (proposed by tjhei) 
https://github.com/dealii/dealii/pull/15634

#15633: Get rid of VectorSpaceVector in the 
LinearAlgebra::distributed::BlockVector class. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/15633

#15632: Mark a 'virtual' function as such. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/15632

#15631: Get rid of VectorSpaceVector in the 
LinearAlgebra::TpetraWrappers::Vector class. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/15631

#15630: github: do not run checks on drafts (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/15630

#15629: Remove remaining deprecations (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/15629

#15628: Only run a test in debug mode. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/15628

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

#15626: Remove LA::Vector. (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/15626

#15625: Significantly expand the orientation module. (proposed by drwells; 
merged) https://github.com/dealii/dealii/pull/15625

#15623: Get rid of VectorSpaceVector in the 
LinearAlgebra::EpetraWrappers::Vector class. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/15623

#15622: Get rid of VectorSpaceVector in the Cuda Vector class. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/15622

#15621: CMake: record git information in a separate configuration file 
(proposed by tamiko; merged) https://github.com/dealii/dealii/pull/15621

#15620: Micro-optimize a loop. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/15620

#15619: Fix missing include file for optimization/line_minimization.h (proposed 
by masterleinad; merged) https://github.com/dealii/dealii/pull/15619

#15618: Use C++17-style fold expressions. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/15618

#15617: CMake: avoid updating deal.II{Config,Targets}.cmake when nothing 
changed (proposed by tamiko; merged) https://github.com/dealii/dealii/pull/15617

#15616: Update the documentation in a few places to refer to C++17. (proposed 
by drwells; merged) https://github.com/dealii/dealii/pull/15616

#15615: Move the save and load function to serial tria (proposed by blaisb; 
merged) https://github.com/dealii/dealii/pull/15615

#15614: Fix range-based for loops over the cells of triangulations. (proposed 
by bangerth; merged) https://github.com/dealii/dealii/pull/15614

#15613: CMake: fix caching of C++ language feature checks (proposed by tamiko; 
merged) https://github.com/dealii/dealii/pull/15613

#15612: lac/trilinos_tpetra...h: Fix compilation on Ubuntu 20.04 (proposed by 
tamiko; merged) https://github.com/dealii/dealii/pull/15612

#15611: Remove deprecated functions in GridReordering (proposed by 
masterleinad; merged) https://github.com/dealii/dealii/pull/15611

#15610: bundle taskflow 3.6.0 (proposed by tjhei) 
https://github.com/dealii/dealii/pull/15610

#15609: Standardize on 'template <typename X>. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/15609

#15608: Introduce tria_orientation.h (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/15608

#15607: disable github CI build of branches (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/15607

#15606: [9.5] Disable parsing 'requires' clauses on the 9.5 branch. (proposed 
by bangerth; merged) https://github.com/dealii/dealii/pull/15606

#15605: Make ParticleHandler serialization tests consistent (proposed by 
pcafrica; merged) https://github.com/dealii/dealii/pull/15605

#15604: Deprecate the contents of the LocalIntegrators namespace. (proposed by 
bangerth) https://github.com/dealii/dealii/pull/15604

#15602: [9.5] lac/scalapack.cc: fix an out-of-bounds write that leads to a 
double free (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/15602

#15601: Test petsc/petsc_ts_05: avoid stack-use-after-return (proposed by 
tamiko; merged) https://github.com/dealii/dealii/pull/15601

#15600: lac/scalapack.cc: fix an out-of-bounds write that leads to a double 
free (proposed by tamiko; merged) https://github.com/dealii/dealii/pull/15600

#15599: Tests: remove fail category (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/15599

#15598: jenkins: test in random order (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/15598

#15597: Test fe/fe_enriched_color_07: fix test (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/15597

#15596: Remove deprecated solve_jacobian_system (proposed by masterleinad; 
merged) https://github.com/dealii/dealii/pull/15596

#15595: [9.5] Allow running step-64 without CUDA (proposed by masterleinad; 
merged) https://github.com/dealii/dealii/pull/15595

#15594: Clear the meaning of  frequency in step-68 (proposed by blaisb; merged) 
https://github.com/dealii/dealii/pull/15594

#15593: Introduce a variable that explicitly names the end time in step-26. 
(proposed by bangerth; merged) https://github.com/dealii/dealii/pull/15593

#15591: Allow running step-64 without CUDA (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/15591

#15590: Add Step-68 performance test (proposed by blaisb; merged) 
https://github.com/dealii/dealii/pull/15590

#15589: Remove deprecated MatrixFree::FE[Face]::Evaluation functions taking 
bools (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/15589

#15588: Fix the step-36 tests. (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/15588

#15587: Default a constructor. (proposed by bangerth) 
https://github.com/dealii/dealii/pull/15587

#15586: Use 'using' instead of 'typedef'. (proposed by bangerth) 
https://github.com/dealii/dealii/pull/15586

#15585: Fix the naming of some function arguments. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/15585

#15584: Fix missing template argument. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/15584

#15583: Fix typo in step-16 (proposed by Rombur; merged) 
https://github.com/dealii/dealii/pull/15583

#15582: Fix the naming of some function arguments. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/15582

#15581: Use ReferenceCell::closest_point() in more places. (proposed by 
drwells; merged) https://github.com/dealii/dealii/pull/15581

#15579: Standardize on 'typename VectorType'. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/15579

#15578: Remove deprecated DoFTools::extract_boundary_dofs (proposed by 
masterleinad; merged) https://github.com/dealii/dealii/pull/15578

#15577: Fix SolutionTransfer to properly compress() vectors. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/15577

#15576: Unified interface for serializing triangulations. (proposed by 
pcafrica) https://github.com/dealii/dealii/pull/15576

#15575: Remove the FEValues instantiation splits. (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/15575

#15573: Fix orientation (proposed by peterrum) 
https://github.com/dealii/dealii/pull/15573

#15572: Add InitFinalize base class of MPI_InitFinalize  (proposed by Rombur) 
https://github.com/dealii/dealii/pull/15572

#15571: Use pinned memory when MPI is not GPU aware (proposed by Rombur; 
merged) https://github.com/dealii/dealii/pull/15571

#15570: Avoid preprocessor define. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/15570

#15569: Avoid unnecessary reinitialization. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/15569

#15568: Minor simplification of some code. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/15568

#15567: Make a constructor 'explicit'. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/15567

#15566: [CI] add arm64 ampere linux build (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/15566

#15565: Error on `create_coarsening_sequence()` with MeshSmoothing on refined 
mesh with one coarse cell (proposed by marcfehling) 
https://github.com/dealii/dealii/pull/15565

#15564: FESystem: do not abuse Subscriptor* as a fancy void* (proposed by 
tamiko; merged) https://github.com/dealii/dealii/pull/15564

#15563: Require C++17 (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/15563

#15562: Fix documentation of parallel::accumulate_from_subranges(). (proposed 
by bangerth; merged) https://github.com/dealii/dealii/pull/15562

#15561: Parallelize some operations in AffineConstraints::close(). (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/15561

#15560: Test example steps directly (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/15560

#15559: Instantiate templates for p::f::T (proposed by pcafrica; merged) 
https://github.com/dealii/dealii/pull/15559

#15558: General: use diamond inheritance for Subscriptor (proposed by tamiko) 
https://github.com/dealii/dealii/pull/15558

#15557: CMake: move a file to a better location (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/15557

#15556: CMake: print a status message after deal_ii_pickup_tests() invocation 
(proposed by tamiko; merged) https://github.com/dealii/dealii/pull/15556

#15555: Remove deprecated Threads functionalities (proposed by masterleinad; 
merged) https://github.com/dealii/dealii/pull/15555

#15554: github-actions: max out cores on macos and windows. (proposed by 
marcfehling; merged) https://github.com/dealii/dealii/pull/15554

#15553: P3 dependencies (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/15553

#15552: Fix ParticleHandler serialization with p::f::T (proposed by pcafrica; 
merged) https://github.com/dealii/dealii/pull/15552

#15551: Remove deprecated FEValuesViews::OutputType (proposed by masterleinad; 
merged) https://github.com/dealii/dealii/pull/15551

#15550: Remove some stray comment. Fix grammar. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/15550

#15549: Use -Werror again in enable_if_supported (proposed by masterleinad; 
merged) https://github.com/dealii/dealii/pull/15549

#15548: Remove ill-defined (and poorly documented) comparison operators for 
AffineConstraints::ConstraintLine. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/15548

#15547: Implement AffineConstraints::ConstraintLine::swap(). (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/15547

#15546: Make step-55 work in 3D. (proposed by marcfehling; merged) 
https://github.com/dealii/dealii/pull/15546

#15545: Make face_vertex_location_location() a lot shorter. (proposed by 
drwells; merged) https://github.com/dealii/dealii/pull/15545

#15544: Simplify constructors/operators of AffineConstraints::ConstraintLine. 
(proposed by bangerth; merged) https://github.com/dealii/dealii/pull/15544

#15543: Remove deprecated LevelSet namespace (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/15543

#15542: Do not allow access to return value of tasks that ended in exceptions. 
(proposed by bangerth; merged) https://github.com/dealii/dealii/pull/15542

#15540: step-86: Use reasonable time stepping for a heat equation solver. 
(proposed by bangerth) https://github.com/dealii/dealii/pull/15540

#15539: Remove deprecated LegacySignal. (proposed by marcfehling; merged) 
https://github.com/dealii/dealii/pull/15539

#15534: Remove deprecated Vector member functions (proposed by masterleinad; 
merged) https://github.com/dealii/dealii/pull/15534

#15530: Remove deprecated functions in fe_interface_values.h (proposed by 
masterleinad; merged) https://github.com/dealii/dealii/pull/15530

#15529: Remove deprecations in consensus algorithms (proposed by masterleinad; 
merged) https://github.com/dealii/dealii/pull/15529

#15528: Remove deprecated CellDataTransferBuffer (proposed by masterleinad; 
merged) https://github.com/dealii/dealii/pull/15528

#15527: FEFaceEvaluation: Fix ECL for continuous elements (proposed by 
bergbauer; merged) https://github.com/dealii/dealii/pull/15527

#15526: CMake: fix submit_results.cmake (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/15526

#15521: Make output of non_nested_transfer tests less verbose (proposed by 
fdrmrc; merged) https://github.com/dealii/dealii/pull/15521

#15520: Shorten compilation time of two MatrixFree tests (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/15520

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

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

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

#15197: Add an abstract base class ReadVector purely for vector access. 
(proposed by drwells; merged) https://github.com/dealii/dealii/pull/15197

#15084: Map boundary to bulk dof iterators. (proposed by luca-heltai; merged) 
https://github.com/dealii/dealii/pull/15084

#15010: Forward implementation of std::bind_front (proposed by sebproell; 
merged) https://github.com/dealii/dealii/pull/15010

#12080: [C++17] Check whether the output directory exists. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/12080

#11066: Use operator^ to create FESystem objects in the tutorials. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/11066


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

#15676: Regression tester regressed 7c7ca6 (opened) 
https://github.com/dealii/dealii/issues/15676

#15663: Regression tester regressed 26653d (opened and closed) 
https://github.com/dealii/dealii/issues/15663

#15659: Regression tester regressed 66236b (opened and closed) 
https://github.com/dealii/dealii/issues/15659

#15650: Performance analysis of step-68 performance test (opened) 
https://github.com/dealii/dealii/issues/15650

#15648: Modernize or remove step-17. (opened) 
https://github.com/dealii/dealii/issues/15648

#15647: Deprecate MatrixTools::apply_boundary_values(). (opened) 
https://github.com/dealii/dealii/issues/15647

#15646: Add a corresponding concept to vector space vector for linear operators 
(opened) https://github.com/dealii/dealii/issues/15646

#15643: Warnings on master (opened and closed) 
https://github.com/dealii/dealii/issues/15643

#15638: Check vector concepts for all of our solvers. (opened) 
https://github.com/dealii/dealii/issues/15638

#15624: LinearAlgebra::{E,T}petraWrappers::Vector::compress() doesn't do 
anything. (opened) https://github.com/dealii/dealii/issues/15624

#15603: Add assertion to make_hanging_node_constraints() to check that the 
AffineConstraints object does not store the entire index set in parallel. 
(opened) https://github.com/dealii/dealii/issues/15603

#15592: doxygen eats PETScWrappers::TimeStepper documentation (opened) 
https://github.com/dealii/dealii/issues/15592

#15580: Regression tester regressed on revision 434975  (opened and closed) 
https://github.com/dealii/dealii/issues/15580

#15574: SolutionTransfer and PETScWrappers::MPI::Vector don't go together 
(opened and closed) https://github.com/dealii/dealii/issues/15574

#15541: `FineDoFHandlerView` encounters cell that is neither locally nor 
remotely owned (opened) https://github.com/dealii/dealii/issues/15541

#15531: OS X tester is broken (closed) 
https://github.com/dealii/dealii/issues/15531

#15504: On Debian Bullseye: Incompatibility with Octave (closed) 
https://github.com/dealii/dealii/issues/15504

#15495: Threads::Task::return_value() should not be allowed when a task ends 
with an exception. (closed) https://github.com/dealii/dealii/issues/15495

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

#15168: Future direction of the different Vector classes in deal.II (closed) 
https://github.com/dealii/dealii/issues/15168

#14854: Standardize on typename VectorType over class VectorType (closed) 
https://github.com/dealii/dealii/issues/14854

#14599: Return MPI_Comm by value in PETSc wrappers. (closed) 
https://github.com/dealii/dealii/issues/14599

#14260: Implement `ReferenceCell::project_to_unit_cell()` (closed) 
https://github.com/dealii/dealii/issues/14260

#13575: New website (closed) https://github.com/dealii/dealii/issues/13575

#10556: PETScVectorBase::max and ::min are currently deprecated (closed) 
https://github.com/dealii/dealii/issues/10556

#10281: [C++17] step-70: Create output directory if necessary (closed) 
https://github.com/dealii/dealii/issues/10281

#8461: move homepage/images/ into a public git repo (closed) 
https://github.com/dealii/dealii/issues/8461

#8367: Cannot compile deal.II 9.1.1 with Trilinos (macOS) (closed) 
https://github.com/dealii/dealii/issues/8367

#7636: Update canonical links on homepage (closed) 
https://github.com/dealii/dealii/issues/7636

#6948: Showcase picture for each tutorial program (closed) 
https://github.com/dealii/dealii/issues/6948

#6947: "Features" tab on the website (closed) 
https://github.com/dealii/dealii/issues/6947

#6946: Provide "showcase" applications on the website (closed) 
https://github.com/dealii/dealii/issues/6946

#6945: Update funding sources on the website (closed) 
https://github.com/dealii/dealii/issues/6945

#4419: Implement a non-owning wrapper mode for PETScWrappers::MatrixBase 
(closed) https://github.com/dealii/dealii/issues/4419

#2535: Route to LA::VectorSpaceVector for parallel::distributed::Vector 
(closed) https://github.com/dealii/dealii/issues/2535


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/64a861cb.050a0220.23b93.d634SMTPIN_ADDED_MISSING%40gmr-mx.google.com.

Reply via email to