deal.II Newsletter #260

32 views
Skip to first unread message

Rene Gassmoeller

unread,
Jul 7, 2023, 3:04:46 PM7/7/23
to dea...@googlegroups.com

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)
#15678: Fix face orientation (proposed by peterrum)
#15677: KINSOL: allow for custom setup (proposed by sebproell)
#15675: Test examples/step-40: avoid std::cout race condition (proposed by tamiko; merged)
#15674: documentation: switch all hyperlinks in the documentation to https:// (proposed by tamiko; merged)
#15673: matrix_free/fe_evaluation.h: avoid a warning with g++-13 (proposed by tamiko; merged)
#15672: Introduce DEAL_II[_DEPRECATED_EARLY]_WITH_COMMENT (proposed by masterleinad; merged)
#15671: Avoid const return type in functions (proposed by masterleinad)
#15670: Tests: update official tester names (proposed by tamiko; merged)
#15669: [9.5] Use -Werror again in enable_if_supported (proposed by tamiko; merged)
#15668: Remove reference to VectorSpacevector from the documentation. (proposed by bangerth; merged)
#15667: Remove reference to VectorSpaceVector from ReadWriteVector's documentation. (proposed by bangerth)
#15666: Remove derivation of LinearAlgebra::distributed::Vector from VectorSpaceVector. (proposed by bangerth; merged)
#15665: Update minimum compiler versions for C++17 (proposed by masterleinad; merged)
#15664: Add a missing typedef to the epetra vector wrapper. (proposed by drwells; merged)
#15661: clang-tidy: Enable readability-container-size-empty check (proposed by masterleinad)
#15660: Fix some comparisons operator for g++-13 with C++20 (proposed by masterleinad; merged)
#15658: Add missing include path for `ReadVector` (proposed by mschreter; merged)
#15657: Fix step-46 tutorial program (proposed by kronbichler; merged)
#15656: Tests: grid/mesh_3d.h: add forgotten GridTests::reorder* call (proposed by tamiko; merged)
#15655: github: update indent worker to Ubuntu 22.04 (proposed by tamiko)
#15654: Tests: add forgotten namespace, fix typo in includes (proposed by tamiko; merged)
#15653: enable examples/ tests in quick tests (proposed by tamiko)
#15652: github: update linux runners (proposed by tamiko)
#15651: Tests: if no numdiff executable is found fall back to running tests instead of dropping them (proposed by tamiko; merged)
#15649: Test serialization for serial and shared triangulations (proposed by pcafrica)
#15645: Change step-68 + timing_step-68 to use FEPointEvaluator (proposed by blaisb; merged)
#15644: Quick tests: also run examples/ tests (proposed by tamiko; merged)
#15642: Test fe/fe_enriched_step-36: make a test less expensive (proposed by tamiko; merged)
#15641: Fix some more clang-tidy findings (proposed by masterleinad)
#15640: Use balanced braces for doxygen formulas. (proposed by bangerth; merged)
#15639: Remove a funny exit path in AffineConstraints::close(). (proposed by bangerth; merged)
#15637: Create a vector space vector concept. (proposed by bangerth; merged)
#15636: base/exceptions.h: avoid warnings in Trilinos / Kokkos headers (proposed by tamiko; merged)
#15635: FEEvaluation: Use n_lanes class variable (proposed by bergbauer; merged)
#15634: Taskflow for async (proposed by tjhei)
#15633: Get rid of VectorSpaceVector in the LinearAlgebra::distributed::BlockVector class. (proposed by bangerth; merged)
#15632: Mark a 'virtual' function as such. (proposed by bangerth; merged)
#15631: Get rid of VectorSpaceVector in the LinearAlgebra::TpetraWrappers::Vector class. (proposed by bangerth; merged)
#15630: github: do not run checks on drafts (proposed by tamiko; merged)
#15629: Remove remaining deprecations (proposed by masterleinad; merged)
#15628: Only run a test in debug mode. (proposed by bangerth; merged)
#15627: Fix the name of a variable. (proposed by bangerth; merged)
#15626: Remove LA::Vector. (proposed by drwells; merged)
#15625: Significantly expand the orientation module. (proposed by drwells; merged)
#15623: Get rid of VectorSpaceVector in the LinearAlgebra::EpetraWrappers::Vector class. (proposed by bangerth; merged)
#15622: Get rid of VectorSpaceVector in the Cuda Vector class. (proposed by bangerth; merged)
#15621: CMake: record git information in a separate configuration file (proposed by tamiko; merged)
#15620: Micro-optimize a loop. (proposed by bangerth; merged)
#15619: Fix missing include file for optimization/line_minimization.h (proposed by masterleinad; merged)
#15618: Use C++17-style fold expressions. (proposed by bangerth; merged)
#15617: CMake: avoid updating deal.II{Config,Targets}.cmake when nothing changed (proposed by tamiko; merged)
#15616: Update the documentation in a few places to refer to C++17. (proposed by drwells; merged)
#15615: Move the save and load function to serial tria (proposed by blaisb; merged)
#15614: Fix range-based for loops over the cells of triangulations. (proposed by bangerth; merged)
#15613: CMake: fix caching of C++ language feature checks (proposed by tamiko; merged)
#15612: lac/trilinos_tpetra...h: Fix compilation on Ubuntu 20.04 (proposed by tamiko; merged)
#15611: Remove deprecated functions in GridReordering (proposed by masterleinad; merged)
#15610: bundle taskflow 3.6.0 (proposed by tjhei)
#15609: Standardize on 'template <typename X>. (proposed by bangerth; merged)
#15608: Introduce tria_orientation.h (proposed by peterrum; merged)
#15607: disable github CI build of branches (proposed by tjhei; merged)
#15606: [9.5] Disable parsing 'requires' clauses on the 9.5 branch. (proposed by bangerth; merged)
#15605: Make ParticleHandler serialization tests consistent (proposed by pcafrica; merged)
#15604: Deprecate the contents of the LocalIntegrators namespace. (proposed by bangerth)
#15602: [9.5] lac/scalapack.cc: fix an out-of-bounds write that leads to a double free (proposed by tamiko; merged)
#15601: Test petsc/petsc_ts_05: avoid stack-use-after-return (proposed by tamiko; merged)
#15600: lac/scalapack.cc: fix an out-of-bounds write that leads to a double free (proposed by tamiko; merged)
#15599: Tests: remove fail category (proposed by tamiko; merged)
#15598: jenkins: test in random order (proposed by tjhei; merged)
#15597: Test fe/fe_enriched_color_07: fix test (proposed by tamiko; merged)
#15596: Remove deprecated solve_jacobian_system (proposed by masterleinad; merged)
#15595: [9.5] Allow running step-64 without CUDA (proposed by masterleinad; merged)
#15594: Clear the meaning of frequency in step-68 (proposed by blaisb; merged)
#15593: Introduce a variable that explicitly names the end time in step-26. (proposed by bangerth; merged)
#15591: Allow running step-64 without CUDA (proposed by masterleinad; merged)
#15590: Add Step-68 performance test (proposed by blaisb; merged)
#15589: Remove deprecated MatrixFree::FE[Face]::Evaluation functions taking bools (proposed by masterleinad; merged)
#15588: Fix the step-36 tests. (proposed by drwells; merged)
#15587: Default a constructor. (proposed by bangerth)
#15586: Use 'using' instead of 'typedef'. (proposed by bangerth)
#15585: Fix the naming of some function arguments. (proposed by bangerth; merged)
#15584: Fix missing template argument. (proposed by bangerth; merged)
#15583: Fix typo in step-16 (proposed by Rombur; merged)
#15582: Fix the naming of some function arguments. (proposed by bangerth; merged)
#15581: Use ReferenceCell::closest_point() in more places. (proposed by drwells; merged)
#15579: Standardize on 'typename VectorType'. (proposed by bangerth; merged)
#15578: Remove deprecated DoFTools::extract_boundary_dofs (proposed by masterleinad; merged)
#15577: Fix SolutionTransfer to properly compress() vectors. (proposed by bangerth; merged)
#15576: Unified interface for serializing triangulations. (proposed by pcafrica)
#15575: Remove the FEValues instantiation splits. (proposed by drwells; merged)
#15573: Fix orientation (proposed by peterrum)
#15572: Add InitFinalize base class of MPI_InitFinalize (proposed by Rombur)
#15571: Use pinned memory when MPI is not GPU aware (proposed by Rombur; merged)
#15570: Avoid preprocessor define. (proposed by bangerth; merged)
#15569: Avoid unnecessary reinitialization. (proposed by bangerth; merged)
#15568: Minor simplification of some code. (proposed by bangerth; merged)
#15567: Make a constructor 'explicit'. (proposed by bangerth; merged)
#15566: [CI] add arm64 ampere linux build (proposed by tjhei; merged)
#15565: Error on `create_coarsening_sequence()` with MeshSmoothing on refined mesh with one coarse cell (proposed by marcfehling)
#15564: FESystem: do not abuse Subscriptor* as a fancy void* (proposed by tamiko; merged)
#15563: Require C++17 (proposed by masterleinad; merged)
#15562: Fix documentation of parallel::accumulate_from_subranges(). (proposed by bangerth; merged)
#15561: Parallelize some operations in AffineConstraints::close(). (proposed by bangerth; merged)
#15560: Test example steps directly (proposed by tjhei; merged)
#15559: Instantiate templates for p::f::T (proposed by pcafrica; merged)
#15558: General: use diamond inheritance for Subscriptor (proposed by tamiko)
#15557: CMake: move a file to a better location (proposed by tamiko; merged)
#15556: CMake: print a status message after deal_ii_pickup_tests() invocation (proposed by tamiko; merged)
#15555: Remove deprecated Threads functionalities (proposed by masterleinad; merged)
#15554: github-actions: max out cores on macos and windows. (proposed by marcfehling; merged)
#15553: P3 dependencies (proposed by drwells; merged)
#15552: Fix ParticleHandler serialization with p::f::T (proposed by pcafrica; merged)
#15551: Remove deprecated FEValuesViews::OutputType (proposed by masterleinad; merged)
#15550: Remove some stray comment. Fix grammar. (proposed by bangerth; merged)
#15549: Use -Werror again in enable_if_supported (proposed by masterleinad; merged)
#15548: Remove ill-defined (and poorly documented) comparison operators for AffineConstraints::ConstraintLine. (proposed by bangerth; merged)
#15547: Implement AffineConstraints::ConstraintLine::swap(). (proposed by bangerth; merged)
#15546: Make step-55 work in 3D. (proposed by marcfehling; merged)
#15545: Make face_vertex_location_location() a lot shorter. (proposed by drwells; merged)
#15544: Simplify constructors/operators of AffineConstraints::ConstraintLine. (proposed by bangerth; merged)
#15543: Remove deprecated LevelSet namespace (proposed by masterleinad; merged)
#15542: Do not allow access to return value of tasks that ended in exceptions. (proposed by bangerth; merged)
#15540: step-86: Use reasonable time stepping for a heat equation solver. (proposed by bangerth)
#15539: Remove deprecated LegacySignal. (proposed by marcfehling; merged)
#15534: Remove deprecated Vector member functions (proposed by masterleinad; merged)
#15530: Remove deprecated functions in fe_interface_values.h (proposed by masterleinad; merged)
#15529: Remove deprecations in consensus algorithms (proposed by masterleinad; merged)
#15528: Remove deprecated CellDataTransferBuffer (proposed by masterleinad; merged)
#15527: FEFaceEvaluation: Fix ECL for continuous elements (proposed by bergbauer; merged)
#15526: CMake: fix submit_results.cmake (proposed by tamiko; merged)
#15521: Make output of non_nested_transfer tests less verbose (proposed by fdrmrc; merged)
#15520: Shorten compilation time of two MatrixFree tests (proposed by kronbichler; merged)
#15445: TriaIterator: return a proper Accessor temporary (proposed by tamiko; merged)
#15401: [Post-9.5] Address some cppcheck findings (proposed by masterleinad; merged)
#15381: MatrixFree: Only set up the inner faces when so requested (proposed by kronbichler; merged)
#15197: Add an abstract base class ReadVector purely for vector access. (proposed by drwells; merged)
#15084: Map boundary to bulk dof iterators. (proposed by luca-heltai; merged)
#15010: Forward implementation of std::bind_front (proposed by sebproell; merged)
#12080: [C++17] Check whether the output directory exists. (proposed by bangerth; merged)
#11066: Use operator^ to create FESystem objects in the tutorials. (proposed by bangerth; merged)

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

#15676 Regression tester regressed 7c7ca6 (opened)
#15663 Regression tester regressed 26653d (opened and closed)
#15659 Regression tester regressed 66236b (opened and closed)
#15650 Performance analysis of step-68 performance test (opened)
#15648 Modernize or remove step-17. (opened)
#15647 Deprecate MatrixTools::apply_boundary_values(). (opened)
#15646 Add a corresponding concept to vector space vector for linear operators (opened)
#15643 Warnings on master (opened and closed)
#15638 Check vector concepts for all of our solvers. (opened)
#15624 LinearAlgebra::{E,T}petraWrappers::Vector::compress() doesn't do anything. (opened)
#15603 Add assertion to make_hanging_node_constraints() to check that the AffineConstraints object does not store the entire index set in parallel. (opened)
#15592 doxygen eats PETScWrappers::TimeStepper documentation (opened)
#15580 Regression tester regressed on revision 434975 (opened and closed)
#15574 SolutionTransfer and PETScWrappers::MPI::Vector don't go together (opened and closed)
#15541 `FineDoFHandlerView` encounters cell that is neither locally nor remotely owned (opened)
#15531 OS X tester is broken (closed)
#15504 On Debian Bullseye: Incompatibility with Octave (closed)
#15495 Threads::Task::return_value() should not be allowed when a task ends with an exception. (closed)
#15440 Binding to TriaAccessor reference returned by dereferencing a TriaIterator temporary leads to use after scope (closed)
#15168 Future direction of the different Vector classes in deal.II (closed)
#14854 Standardize on typename VectorType over class VectorType (closed)
#14599 Return MPI_Comm by value in PETSc wrappers. (closed)
#14260 Implement `ReferenceCell::project_to_unit_cell()` (closed)
#13575 New website (closed)
#10556 PETScVectorBase::max and ::min are currently deprecated (closed)
#10281 [C++17] step-70: Create output directory if necessary (closed)
#8461 move homepage/images/ into a public git repo (closed)
#8367 Cannot compile deal.II 9.1.1 with Trilinos (macOS) (closed)
#7636 Update canonical links on homepage (closed)
#6948 Showcase picture for each tutorial program (closed)
#6947 "Features" tab on the website (closed)
#6946 Provide "showcase" applications on the website (closed)
#6945 Update funding sources on the website (closed)
#4419 Implement a non-owning wrapper mode for PETScWrappers::MatrixBase (closed)
#2535 Route to LA::VectorSpaceVector for parallel::distributed::Vector (closed)

A list of all major changes since the last release can be found at this website.

Thanks for being part of the community!

Let us know about questions, problems, bugs or just share your experience by writing to this mailing list, or by opening issues or pull requests on Github.
Additional information can be found at our official website.

Wolfgang Bangerth

unread,
Jul 7, 2023, 3:27:03 PM7/7/23
to dea...@googlegroups.com

All:
the list Rene just sent around includes around 170 changes, some of which have
been in the pipeline for several years already. This is the result of ten of
the Principal Developers getting together for a week in Clemson, SC (organized
by Timo Heister) for a hackathon. Many exciting features were implemented that
will all appear in the release next year -- excellent work by everyone!

In the meantime, deal.II 9.5 is about to come out in the next few days too!

Best
W.


On 7/7/23 13:04, 'Rene Gassmoeller' via deal.II User Group wrote:
> *** Caution: EXTERNAL Sender ***
>
> 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
> <https://github.com/dealii/dealii/pull/15679>: Use parallel::apply_to_subranges(). (proposed by bangerth <https://github.com/bangerth>)
> #15678
> <https://github.com/dealii/dealii/pull/15678>: Fix face orientation (proposed by peterrum <https://github.com/peterrum>)
> #15677
> <https://github.com/dealii/dealii/pull/15677>: KINSOL: allow for custom setup (proposed by sebproell <https://github.com/sebproell>)
> #15675
> <https://github.com/dealii/dealii/pull/15675>: Test examples/step-40: avoid std::cout race condition (proposed by tamiko <https://github.com/tamiko>; merged)
> #15674
> <https://github.com/dealii/dealii/pull/15674>: documentation: switch all hyperlinks in the documentation to https:// (proposed by tamiko <https://github.com/tamiko>; merged)
> #15673
> <https://github.com/dealii/dealii/pull/15673>: matrix_free/fe_evaluation.h: avoid a warning with g++-13 (proposed by tamiko <https://github.com/tamiko>; merged)
> #15672
> <https://github.com/dealii/dealii/pull/15672>: Introduce DEAL_II[_DEPRECATED_EARLY]_WITH_COMMENT (proposed by masterleinad <https://github.com/masterleinad>; merged)
> #15671
> <https://github.com/dealii/dealii/pull/15671>: Avoid const return type in functions (proposed by masterleinad <https://github.com/masterleinad>)
> #15670
> <https://github.com/dealii/dealii/pull/15670>: Tests: update official tester names (proposed by tamiko <https://github.com/tamiko>; merged)
> #15669
> <https://github.com/dealii/dealii/pull/15669>: [9.5] Use -Werror again in enable_if_supported (proposed by tamiko <https://github.com/tamiko>; merged)
> #15668
> <https://github.com/dealii/dealii/pull/15668>: Remove reference to VectorSpacevector from the documentation. (proposed by bangerth <https://github.com/bangerth>; merged)
> #15667
> <https://github.com/dealii/dealii/pull/15667>: Remove reference to VectorSpaceVector from ReadWriteVector's documentation. (proposed by bangerth <https://github.com/bangerth>)
> #15666
> <https://github.com/dealii/dealii/pull/15666>: Remove derivation of LinearAlgebra::distributed::Vector from VectorSpaceVector. (proposed by bangerth <https://github.com/bangerth>; merged)
> #15665
> <https://github.com/dealii/dealii/pull/15665>: Update minimum compiler versions for C++17 (proposed by masterleinad <https://github.com/masterleinad>; merged)
> #15664
> <https://github.com/dealii/dealii/pull/15664>: Add a missing typedef to the epetra vector wrapper. (proposed by drwells <https://github.com/drwells>; merged)
> #15661
> <https://github.com/dealii/dealii/pull/15661>: clang-tidy: Enable readability-container-size-empty check (proposed by masterleinad <https://github.com/masterleinad>)
> #15660
> <https://github.com/dealii/dealii/pull/15660>: Fix some comparisons operator for g++-13 with C++20 (proposed by masterleinad <https://github.com/masterleinad>; merged)
> #15658
> <https://github.com/dealii/dealii/pull/15658>: Add missing include path for `ReadVector` (proposed by mschreter <https://github.com/mschreter>; merged)
> #15657
> <https://github.com/dealii/dealii/pull/15657>: Fix step-46 tutorial program (proposed by kronbichler <https://github.com/kronbichler>; merged)
> #15656
> <https://github.com/dealii/dealii/pull/15656>: Tests: grid/mesh_3d.h: add forgotten GridTests::reorder* call (proposed by tamiko <https://github.com/tamiko>; merged)
> #15655
> <https://github.com/dealii/dealii/pull/15655>: github: update indent worker to Ubuntu 22.04 (proposed by tamiko <https://github.com/tamiko>)
> #15654
> <https://github.com/dealii/dealii/pull/15654>: Tests: add forgotten namespace, fix typo in includes (proposed by tamiko <https://github.com/tamiko>; merged)
> #15653
> <https://github.com/dealii/dealii/pull/15653>: enable examples/ tests in quick tests (proposed by tamiko <https://github.com/tamiko>)
> #15652
> <https://github.com/dealii/dealii/pull/15652>: github: update linux runners (proposed by tamiko <https://github.com/tamiko>)
> #15651
> <https://github.com/dealii/dealii/pull/15651>: Tests: if no numdiff executable is found fall back to running tests instead of dropping them (proposed by tamiko <https://github.com/tamiko>; merged)
> #15649
> <https://github.com/dealii/dealii/pull/15649>: Test serialization for serial and shared triangulations (proposed by pcafrica <https://github.com/pcafrica>)
> #15645
> <https://github.com/dealii/dealii/pull/15645>: Change step-68 + timing_step-68 to use FEPointEvaluator (proposed by blaisb <https://github.com/blaisb>; merged)
> #15644
> <https://github.com/dealii/dealii/pull/15644>: Quick tests: also run examples/ tests (proposed by tamiko <https://github.com/tamiko>; merged)
> #15642
> <https://github.com/dealii/dealii/pull/15642>: Test fe/fe_enriched_step-36: make a test less expensive (proposed by tamiko <https://github.com/tamiko>; merged)
> #15641
> <https://github.com/dealii/dealii/pull/15641>: Fix some more clang-tidy findings (proposed by masterleinad <https://github.com/masterleinad>)
> #15640
> <https://github.com/dealii/dealii/pull/15640>: Use balanced braces for doxygen formulas. (proposed by bangerth <https://github.com/bangerth>; merged)
> #15639
> <https://github.com/dealii/dealii/pull/15639>: Remove a funny exit path in AffineConstraints::close(). (proposed by bangerth <https://github.com/bangerth>; merged)
> #15637
> <https://github.com/dealii/dealii/pull/15637>: Create a vector space vector concept. (proposed by bangerth <https://github.com/bangerth>; merged)
> #15636
> <https://github.com/dealii/dealii/pull/15636>: base/exceptions.h: avoid warnings in Trilinos / Kokkos headers (proposed by tamiko <https://github.com/tamiko>; merged)
> #15635
> <https://github.com/dealii/dealii/pull/15635>: FEEvaluation: Use n_lanes class variable (proposed by bergbauer <https://github.com/bergbauer>; merged)
> #15634
> <https://github.com/dealii/dealii/pull/15634>: Taskflow for async (proposed by tjhei <https://github.com/tjhei>)
> #15633
> <https://github.com/dealii/dealii/pull/15633>: Get rid of VectorSpaceVector in the LinearAlgebra::distributed::BlockVector class. (proposed by bangerth <https://github.com/bangerth>; merged)
> #15632
> <https://github.com/dealii/dealii/pull/15632>: Mark a 'virtual' function as such. (proposed by bangerth <https://github.com/bangerth>; merged)
> #15631
> <https://github.com/dealii/dealii/pull/15631>: Get rid of VectorSpaceVector in the LinearAlgebra::TpetraWrappers::Vector class. (proposed by bangerth <https://github.com/bangerth>; merged)
> #15630
> <https://github.com/dealii/dealii/pull/15630>: github: do not run checks on drafts (proposed by tamiko <https://github.com/tamiko>; merged)
> #15629
> <https://github.com/dealii/dealii/pull/15629>: Remove remaining deprecations (proposed by masterleinad <https://github.com/masterleinad>; merged)
> #15628
> <https://github.com/dealii/dealii/pull/15628>: Only run a test in debug mode. (proposed by bangerth <https://github.com/bangerth>; merged)
> #15627
> <https://github.com/dealii/dealii/pull/15627>: Fix the name of a variable. (proposed by bangerth <https://github.com/bangerth>; merged)
> #15626
> <https://github.com/dealii/dealii/pull/15626>: Remove LA::Vector. (proposed by drwells <https://github.com/drwells>; merged)
> #15625
> <https://github.com/dealii/dealii/pull/15625>: Significantly expand the orientation module. (proposed by drwells <https://github.com/drwells>; merged)
> #15623
> <https://github.com/dealii/dealii/pull/15623>: Get rid of VectorSpaceVector in the LinearAlgebra::EpetraWrappers::Vector class. (proposed by bangerth <https://github.com/bangerth>; merged)
> #15622
> <https://github.com/dealii/dealii/pull/15622>: Get rid of VectorSpaceVector in the Cuda Vector class. (proposed by bangerth <https://github.com/bangerth>; merged)
> #15621
> <https://github.com/dealii/dealii/pull/15621>: CMake: record git information in a separate configuration file (proposed by tamiko <https://github.com/tamiko>; merged)
> #15620
> <https://github.com/dealii/dealii/pull/15620>: Micro-optimize a loop. (proposed by bangerth <https://github.com/bangerth>; merged)
> #15619
> <https://github.com/dealii/dealii/pull/15619>: Fix missing include file for optimization/line_minimization.h (proposed by masterleinad <https://github.com/masterleinad>; merged)
> #15618
> <https://github.com/dealii/dealii/pull/15618>: Use C++17-style fold expressions. (proposed by bangerth <https://github.com/bangerth>; merged)
> #15617
> <https://github.com/dealii/dealii/pull/15617>: CMake: avoid updating deal.II{Config,Targets}.cmake when nothing changed (proposed by tamiko <https://github.com/tamiko>; merged)
> #15616
> <https://github.com/dealii/dealii/pull/15616>: Update the documentation in a few places to refer to C++17. (proposed by drwells <https://github.com/drwells>; merged)
> #15615
> <https://github.com/dealii/dealii/pull/15615>: Move the save and load function to serial tria (proposed by blaisb <https://github.com/blaisb>; merged)
> #15614
> <https://github.com/dealii/dealii/pull/15614>: Fix range-based for loops over the cells of triangulations. (proposed by bangerth <https://github.com/bangerth>; merged)
> #15613
> <https://github.com/dealii/dealii/pull/15613>: CMake: fix caching of C++ language feature checks (proposed by tamiko <https://github.com/tamiko>; merged)
> #15612
> <https://github.com/dealii/dealii/pull/15612>: lac/trilinos_tpetra...h: Fix compilation on Ubuntu 20.04 (proposed by tamiko <https://github.com/tamiko>; merged)
> #15611
> <https://github.com/dealii/dealii/pull/15611>: Remove deprecated functions in GridReordering (proposed by masterleinad <https://github.com/masterleinad>; merged)
> #15610
> <https://github.com/dealii/dealii/pull/15610>: bundle taskflow 3.6.0 (proposed by tjhei <https://github.com/tjhei>)
> #15609
> <https://github.com/dealii/dealii/pull/15609>: Standardize on 'template <typename X>. (proposed by bangerth <https://github.com/bangerth>; merged)
> #15608
> <https://github.com/dealii/dealii/pull/15608>: Introduce tria_orientation.h (proposed by peterrum <https://github.com/peterrum>; merged)
> #15607
> <https://github.com/dealii/dealii/pull/15607>: disable github CI build of branches (proposed by tjhei <https://github.com/tjhei>; merged)
> #15606
> <https://github.com/dealii/dealii/pull/15606>: [9.5] Disable parsing 'requires' clauses on the 9.5 branch. (proposed by bangerth <https://github.com/bangerth>; merged)
> #15605
> <https://github.com/dealii/dealii/pull/15605>: Make ParticleHandler serialization tests consistent (proposed by pcafrica <https://github.com/pcafrica>; merged)
> #15604
> <https://github.com/dealii/dealii/pull/15604>: Deprecate the contents of the LocalIntegrators namespace. (proposed by bangerth <https://github.com/bangerth>)
> #15602
> <https://github.com/dealii/dealii/pull/15602>: [9.5] lac/scalapack.cc: fix an out-of-bounds write that leads to a double free (proposed by tamiko <https://github.com/tamiko>; merged)
> #15601
> <https://github.com/dealii/dealii/pull/15601>: Test petsc/petsc_ts_05: avoid stack-use-after-return (proposed by tamiko <https://github.com/tamiko>; merged)
> #15600
> <https://github.com/dealii/dealii/pull/15600>: lac/scalapack.cc: fix an out-of-bounds write that leads to a double free (proposed by tamiko <https://github.com/tamiko>; merged)
> #15599
> <https://github.com/dealii/dealii/pull/15599>: Tests: remove fail category (proposed by tamiko <https://github.com/tamiko>; merged)
> #15598
> <https://github.com/dealii/dealii/pull/15598>: jenkins: test in random order (proposed by tjhei <https://github.com/tjhei>; merged)
> #15597
> <https://github.com/dealii/dealii/pull/15597>: Test fe/fe_enriched_color_07: fix test (proposed by tamiko <https://github.com/tamiko>; merged)
> #15596
> <https://github.com/dealii/dealii/pull/15596>: Remove deprecated solve_jacobian_system (proposed by masterleinad <https://github.com/masterleinad>; merged)
> #15595
> <https://github.com/dealii/dealii/pull/15595>: [9.5] Allow running step-64 without CUDA (proposed by masterleinad <https://github.com/masterleinad>; merged)
> #15594
> <https://github.com/dealii/dealii/pull/15594>: Clear the meaning of frequency in step-68 (proposed by blaisb <https://github.com/blaisb>; merged)
> #15593
> <https://github.com/dealii/dealii/pull/15593>: Introduce a variable that explicitly names the end time in step-26. (proposed by bangerth <https://github.com/bangerth>; merged)
> #15591
> <https://github.com/dealii/dealii/pull/15591>: Allow running step-64 without CUDA (proposed by masterleinad <https://github.com/masterleinad>; merged)
> #15590
> <https://github.com/dealii/dealii/pull/15590>: Add Step-68 performance test (proposed by blaisb <https://github.com/blaisb>; merged)
> #15589
> <https://github.com/dealii/dealii/pull/15589>: Remove deprecated MatrixFree::FE[Face]::Evaluation functions taking bools (proposed by masterleinad <https://github.com/masterleinad>; merged)
> #15588
> <https://github.com/dealii/dealii/pull/15588>: Fix the step-36 tests. (proposed by drwells <https://github.com/drwells>; merged)
> #15587
> <https://github.com/dealii/dealii/pull/15587>: Default a constructor. (proposed by bangerth <https://github.com/bangerth>)
> #15586
> <https://github.com/dealii/dealii/pull/15586>: Use 'using' instead of 'typedef'. (proposed by bangerth <https://github.com/bangerth>)
> #15585
> <https://github.com/dealii/dealii/pull/15585>: Fix the naming of some function arguments. (proposed by bangerth <https://github.com/bangerth>; merged)
> #15584
> <https://github.com/dealii/dealii/pull/15584>: Fix missing template argument. (proposed by bangerth <https://github.com/bangerth>; merged)
> #15583
> <https://github.com/dealii/dealii/pull/15583>: Fix typo in step-16 (proposed by Rombur <https://github.com/Rombur>; merged)
> #15582
> <https://github.com/dealii/dealii/pull/15582>: Fix the naming of some function arguments. (proposed by bangerth <https://github.com/bangerth>; merged)
> #15581
> <https://github.com/dealii/dealii/pull/15581>: Use ReferenceCell::closest_point() in more places. (proposed by drwells <https://github.com/drwells>; merged)
> #15579
> <https://github.com/dealii/dealii/pull/15579>: Standardize on 'typename VectorType'. (proposed by bangerth <https://github.com/bangerth>; merged)
> #15578
> <https://github.com/dealii/dealii/pull/15578>: Remove deprecated DoFTools::extract_boundary_dofs (proposed by masterleinad <https://github.com/masterleinad>; merged)
> #15577
> <https://github.com/dealii/dealii/pull/15577>: Fix SolutionTransfer to properly compress() vectors. (proposed by bangerth <https://github.com/bangerth>; merged)
> #15576
> <https://github.com/dealii/dealii/pull/15576>: Unified interface for serializing triangulations. (proposed by pcafrica <https://github.com/pcafrica>)
> #15575
> <https://github.com/dealii/dealii/pull/15575>: Remove the FEValues instantiation splits. (proposed by drwells <https://github.com/drwells>; merged)
> #15573
> <https://github.com/dealii/dealii/pull/15573>: Fix orientation (proposed by peterrum <https://github.com/peterrum>)
> #15572
> <https://github.com/dealii/dealii/pull/15572>: Add InitFinalize base class of MPI_InitFinalize (proposed by Rombur <https://github.com/Rombur>)
> #15571
> <https://github.com/dealii/dealii/pull/15571>: Use pinned memory when MPI is not GPU aware (proposed by Rombur <https://github.com/Rombur>; merged)
> #15570
> <https://github.com/dealii/dealii/pull/15570>: Avoid preprocessor define. (proposed by bangerth <https://github.com/bangerth>; merged)
> #15569
> <https://github.com/dealii/dealii/pull/15569>: Avoid unnecessary reinitialization. (proposed by bangerth <https://github.com/bangerth>; merged)
> #15568
> <https://github.com/dealii/dealii/pull/15568>: Minor simplification of some code. (proposed by bangerth <https://github.com/bangerth>; merged)
> #15567
> <https://github.com/dealii/dealii/pull/15567>: Make a constructor 'explicit'. (proposed by bangerth <https://github.com/bangerth>; merged)
> #15566
> <https://github.com/dealii/dealii/pull/15566>: [CI] add arm64 ampere linux build (proposed by tjhei <https://github.com/tjhei>; merged)
> #15565
> <https://github.com/dealii/dealii/pull/15565>: Error on `create_coarsening_sequence()` with MeshSmoothing on refined mesh with one coarse cell (proposed by marcfehling <https://github.com/marcfehling>)
> #15564
> <https://github.com/dealii/dealii/pull/15564>: FESystem: do not abuse Subscriptor* as a fancy void* (proposed by tamiko <https://github.com/tamiko>; merged)
> #15563
> <https://github.com/dealii/dealii/pull/15563>: Require C++17 (proposed by masterleinad <https://github.com/masterleinad>; merged)
> #15562
> <https://github.com/dealii/dealii/pull/15562>: Fix documentation of parallel::accumulate_from_subranges(). (proposed by bangerth <https://github.com/bangerth>; merged)
> #15561
> <https://github.com/dealii/dealii/pull/15561>: Parallelize some operations in AffineConstraints::close(). (proposed by bangerth <https://github.com/bangerth>; merged)
> #15560
> <https://github.com/dealii/dealii/pull/15560>: Test example steps directly (proposed by tjhei <https://github.com/tjhei>; merged)
> #15559
> <https://github.com/dealii/dealii/pull/15559>: Instantiate templates for p::f::T (proposed by pcafrica <https://github.com/pcafrica>; merged)
> #15558
> <https://github.com/dealii/dealii/pull/15558>: General: use diamond inheritance for Subscriptor (proposed by tamiko <https://github.com/tamiko>)
> #15557
> <https://github.com/dealii/dealii/pull/15557>: CMake: move a file to a better location (proposed by tamiko <https://github.com/tamiko>; merged)
> #15556
> <https://github.com/dealii/dealii/pull/15556>: CMake: print a status message after deal_ii_pickup_tests() invocation (proposed by tamiko <https://github.com/tamiko>; merged)
> #15555
> <https://github.com/dealii/dealii/pull/15555>: Remove deprecated Threads functionalities (proposed by masterleinad <https://github.com/masterleinad>; merged)
> #15554
> <https://github.com/dealii/dealii/pull/15554>: github-actions: max out cores on macos and windows. (proposed by marcfehling <https://github.com/marcfehling>; merged)
> #15553
> <https://github.com/dealii/dealii/pull/15553>: P3 dependencies (proposed by drwells <https://github.com/drwells>; merged)
> #15552
> <https://github.com/dealii/dealii/pull/15552>: Fix ParticleHandler serialization with p::f::T (proposed by pcafrica <https://github.com/pcafrica>; merged)
> #15551
> <https://github.com/dealii/dealii/pull/15551>: Remove deprecated FEValuesViews::OutputType (proposed by masterleinad <https://github.com/masterleinad>; merged)
> #15550
> <https://github.com/dealii/dealii/pull/15550>: Remove some stray comment. Fix grammar. (proposed by bangerth <https://github.com/bangerth>; merged)
> #15549
> <https://github.com/dealii/dealii/pull/15549>: Use -Werror again in enable_if_supported (proposed by masterleinad <https://github.com/masterleinad>; merged)
> #15548
> <https://github.com/dealii/dealii/pull/15548>: Remove ill-defined (and poorly documented) comparison operators for AffineConstraints::ConstraintLine. (proposed by bangerth <https://github.com/bangerth>; merged)
> #15547
> <https://github.com/dealii/dealii/pull/15547>: Implement AffineConstraints::ConstraintLine::swap(). (proposed by bangerth <https://github.com/bangerth>; merged)
> #15546
> <https://github.com/dealii/dealii/pull/15546>: Make step-55 work in 3D. (proposed by marcfehling <https://github.com/marcfehling>; merged)
> #15545
> <https://github.com/dealii/dealii/pull/15545>: Make face_vertex_location_location() a lot shorter. (proposed by drwells <https://github.com/drwells>; merged)
> #15544
> <https://github.com/dealii/dealii/pull/15544>: Simplify constructors/operators of AffineConstraints::ConstraintLine. (proposed by bangerth <https://github.com/bangerth>; merged)
> #15543
> <https://github.com/dealii/dealii/pull/15543>: Remove deprecated LevelSet namespace (proposed by masterleinad <https://github.com/masterleinad>; merged)
> #15542
> <https://github.com/dealii/dealii/pull/15542>: Do not allow access to return value of tasks that ended in exceptions. (proposed by bangerth <https://github.com/bangerth>; merged)
> #15540
> <https://github.com/dealii/dealii/pull/15540>: step-86: Use reasonable time stepping for a heat equation solver. (proposed by bangerth <https://github.com/bangerth>)
> #15539
> <https://github.com/dealii/dealii/pull/15539>: Remove deprecated LegacySignal. (proposed by marcfehling <https://github.com/marcfehling>; merged)
> #15534
> <https://github.com/dealii/dealii/pull/15534>: Remove deprecated Vector member functions (proposed by masterleinad <https://github.com/masterleinad>; merged)
> #15530
> <https://github.com/dealii/dealii/pull/15530>: Remove deprecated functions in fe_interface_values.h (proposed by masterleinad <https://github.com/masterleinad>; merged)
> #15529
> <https://github.com/dealii/dealii/pull/15529>: Remove deprecations in consensus algorithms (proposed by masterleinad <https://github.com/masterleinad>; merged)
> #15528
> <https://github.com/dealii/dealii/pull/15528>: Remove deprecated CellDataTransferBuffer (proposed by masterleinad <https://github.com/masterleinad>; merged)
> #15527
> <https://github.com/dealii/dealii/pull/15527>: FEFaceEvaluation: Fix ECL for continuous elements (proposed by bergbauer <https://github.com/bergbauer>; merged)
> #15526
> <https://github.com/dealii/dealii/pull/15526>: CMake: fix submit_results.cmake (proposed by tamiko <https://github.com/tamiko>; merged)
> #15521
> <https://github.com/dealii/dealii/pull/15521>: Make output of non_nested_transfer tests less verbose (proposed by fdrmrc <https://github.com/fdrmrc>; merged)
> #15520
> <https://github.com/dealii/dealii/pull/15520>: Shorten compilation time of two MatrixFree tests (proposed by kronbichler <https://github.com/kronbichler>; merged)
> #15445
> <https://github.com/dealii/dealii/pull/15445>: TriaIterator: return a proper Accessor temporary (proposed by tamiko <https://github.com/tamiko>; merged)
> #15401
> <https://github.com/dealii/dealii/pull/15401>: [Post-9.5] Address some cppcheck findings (proposed by masterleinad <https://github.com/masterleinad>; merged)
> #15381
> <https://github.com/dealii/dealii/pull/15381>: MatrixFree: Only set up the inner faces when so requested (proposed by kronbichler <https://github.com/kronbichler>; merged)
> #15197
> <https://github.com/dealii/dealii/pull/15197>: Add an abstract base class ReadVector purely for vector access. (proposed by drwells <https://github.com/drwells>; merged)
> #15084
> <https://github.com/dealii/dealii/pull/15084>: Map boundary to bulk dof iterators. (proposed by luca-heltai <https://github.com/luca-heltai>; merged)
> #15010
> <https://github.com/dealii/dealii/pull/15010>: Forward implementation of std::bind_front (proposed by sebproell <https://github.com/sebproell>; merged)
> #12080
> <https://github.com/dealii/dealii/pull/12080>: [C++17] Check whether the output directory exists. (proposed by bangerth <https://github.com/bangerth>; merged)
> #11066
> <https://github.com/dealii/dealii/pull/11066>: Use operator^ to create FESystem objects in the tutorials. (proposed by bangerth <https://github.com/bangerth>; merged)
>
> And this is a list of recently opened or closed discussions:
>
> #15676
> <https://github.com/dealii/dealii/issues/15676> Regression tester regressed 7c7ca6 (opened)
> #15663
> <https://github.com/dealii/dealii/issues/15663> Regression tester regressed 26653d (opened and closed)
> #15659
> <https://github.com/dealii/dealii/issues/15659> Regression tester regressed 66236b (opened and closed)
> #15650
> <https://github.com/dealii/dealii/issues/15650> Performance analysis of step-68 performance test (opened)
> #15648
> <https://github.com/dealii/dealii/issues/15648> Modernize or remove step-17. (opened)
> #15647
> <https://github.com/dealii/dealii/issues/15647> Deprecate MatrixTools::apply_boundary_values(). (opened)
> #15646
> <https://github.com/dealii/dealii/issues/15646> Add a corresponding concept to vector space vector for linear operators (opened)
> #15643
> <https://github.com/dealii/dealii/issues/15643> Warnings on master (opened and closed)
> #15638
> <https://github.com/dealii/dealii/issues/15638> Check vector concepts for all of our solvers. (opened)
> #15624
> <https://github.com/dealii/dealii/issues/15624> LinearAlgebra::{E,T}petraWrappers::Vector::compress() doesn't do anything. (opened)
> #15603
> <https://github.com/dealii/dealii/issues/15603> Add assertion to make_hanging_node_constraints() to check that the AffineConstraints object does not store the entire index set in parallel. (opened)
> #15592
> <https://github.com/dealii/dealii/issues/15592> doxygen eats PETScWrappers::TimeStepper documentation (opened)
> #15580
> <https://github.com/dealii/dealii/issues/15580> Regression tester regressed on revision 434975 (opened and closed)
> #15574
> <https://github.com/dealii/dealii/issues/15574> SolutionTransfer and PETScWrappers::MPI::Vector don't go together (opened and closed)
> #15541
> <https://github.com/dealii/dealii/issues/15541> `FineDoFHandlerView` encounters cell that is neither locally nor remotely owned (opened)
> #15531
> <https://github.com/dealii/dealii/issues/15531> OS X tester is broken (closed)
> #15504
> <https://github.com/dealii/dealii/issues/15504> On Debian Bullseye: Incompatibility with Octave (closed)
> #15495
> <https://github.com/dealii/dealii/issues/15495> Threads::Task::return_value() should not be allowed when a task ends with an exception. (closed)
> #15440
> <https://github.com/dealii/dealii/issues/15440> Binding to TriaAccessor reference returned by dereferencing a TriaIterator temporary leads to use after scope (closed)
> #15168
> <https://github.com/dealii/dealii/issues/15168> Future direction of the different Vector classes in deal.II (closed)
> #14854
> <https://github.com/dealii/dealii/issues/14854> Standardize on typename VectorType over class VectorType (closed)
> #14599
> <https://github.com/dealii/dealii/issues/14599> Return MPI_Comm by value in PETSc wrappers. (closed)
> #14260
> <https://github.com/dealii/dealii/issues/14260> Implement `ReferenceCell::project_to_unit_cell()` (closed)
> #13575
> <https://github.com/dealii/dealii/issues/13575> New website (closed)
> #10556
> <https://github.com/dealii/dealii/issues/10556> PETScVectorBase::max and ::min are currently deprecated (closed)
> #10281
> <https://github.com/dealii/dealii/issues/10281> [C++17] step-70: Create output directory if necessary (closed)
> #8461
> <https://github.com/dealii/dealii/issues/8461> move homepage/images/ into a public git repo (closed)
> #8367
> <https://github.com/dealii/dealii/issues/8367> Cannot compile deal.II 9.1.1 with Trilinos (macOS) (closed)
> #7636
> <https://github.com/dealii/dealii/issues/7636> Update canonical links on homepage (closed)
> #6948
> <https://github.com/dealii/dealii/issues/6948> Showcase picture for each tutorial program (closed)
> #6947
> <https://github.com/dealii/dealii/issues/6947> "Features" tab on the website (closed)
> #6946
> <https://github.com/dealii/dealii/issues/6946> Provide "showcase" applications on the website (closed)
> #6945
> <https://github.com/dealii/dealii/issues/6945> Update funding sources on the website (closed)
> #4419
> <https://github.com/dealii/dealii/issues/4419> Implement a non-owning wrapper mode for PETScWrappers::MatrixBase (closed)
> #2535
> <https://github.com/dealii/dealii/issues/2535> Route to LA::VectorSpaceVector for parallel::distributed::Vector (closed)
>
> A list of all major changes since the last release can be found at this
> website
> <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 this mailing list <mailto:dea...@googlegroups.com>, or by opening
> issues or pull requests on Github
> <https://www.github.com/dealii/dealii>.
> Additional information can be found at our official website
> <https://www.dealii.org/>.
>
> --
> The deal.II project is located at http://www.dealii.org/
> <http://www.dealii.org/>
> For mailing list/forum options, see
> https://groups.google.com/d/forum/dealii?hl=en
> <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+un...@googlegroups.com
> <mailto:dealii+un...@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 <https://groups.google.com/d/msgid/dealii/64a861cb.050a0220.23b93.d634SMTPIN_ADDED_MISSING%40gmr-mx.google.com?utm_medium=email&utm_source=footer>.

--
------------------------------------------------------------------------
Wolfgang Bangerth email: bang...@colostate.edu
www: http://www.math.colostate.edu/~bangerth/


Reply all
Reply to author
Forward
0 new messages