deal.II Newsletter #261

20 views
Skip to first unread message

Rene Gassmoeller

unread,
Jul 14, 2023, 3:01:11 PM7/14/23
to dea...@googlegroups.com

Hello everyone!

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

#15746: [C++17] Prefer std::is_base_of_v over std::is_base_of::value. (proposed by bangerth)
#15745: Small markup fixes. (proposed by bangerth)
#15744: Add missing changelog entry about the improvement to step-68 (proposed by blaisb)
#15743: Test mpi/petsc_step-27: fix race condition for output file (proposed by tamiko; merged)
#15740: [C++17] Use std::is_floating_point_v instead of std::is_floating_point<...>::value. (proposed by bangerth; merged)
#15739: [C++17] Use std::is_same_v instead of std::is_same<...>::value. (proposed by bangerth; merged)
#15737: Copy Tpetra vector if we need to call "sync" (proposed by masterleinad; merged)
#15736: Only warn about deprecated std_cxx17 headers for DEAL_II_EARLY_DEPRECATIONS (proposed by masterleinad; merged)
#15735: Make VectorizedArray::sum() const (proposed by peterrum; merged)
#15734: README.md: update and rearrange badges (proposed by tamiko; merged)
#15731: Use "empty()" instead of "size() == 0" (proposed by masterleinad)
#15730: Keep track of constraints we have already determined are finalized. (proposed by bangerth)
#15729: MatrixFree: Memory consumption of mapping data faces by cells in MappingInfo (proposed by bergbauer; merged)
#15727: Simplify a few places using cell->as_dof_handler_iterator(..). (proposed by simonsticko; merged)
#15726: [9.5] bundled/tbb: fix compilation with gcc-13 (proposed by tamiko; merged)
#15725: bundled/tbb: fix compilation with gcc-13 (proposed by tamiko; merged)
#15723: Don't use diff option (proposed by tamiko; merged)
#15722: README.md: reorganize badges in a nice row (proposed by tamiko; merged)
#15721: tests/examples/ fix script return value (proposed by tjhei; merged)
#15720: Add 1d support for ArborXWrappers (proposed by masterleinad; merged)
#15719: Testsuite: let run_testsuite() print a summary (proposed by tamiko; merged)
#15718: empty() function for Quadrature (proposed by bergbauer; merged)
#15717: Timing step-68: Fix warnings + remove unnecessary mpi call (proposed by blaisb; merged)
#15716: CMake: remove support for ctest_memcheck() and run_memorycheck.cmake (proposed by tamiko; merged)
#15715: Re-add LinearAlgebra::set_zero_mean_value(). (proposed by bangerth; merged)
#15713: Some more small AffineConstraints code improvements. (proposed by bangerth; merged)
#15711: Recommend NOX for building Trilinos. (proposed by bangerth; merged)
#15709: Restrict tests requiring NOX (proposed by masterleinad; merged)
#15708: [9.5] Guard NOX support in include/deal.II/numerics/nonlinear.h (proposed by masterleinad; merged)
#15707: Triangulation::CellStatus: provide proper compatibility type (proposed by tamiko; merged)
#15706: SolutionTransfer for (de)serializing serial triangulations (proposed by pcafrica)
#15705: Use readability-qualified-auto clang-tidy check (proposed by masterleinad; merged)
#15704: Guard NOX support in include/deal.II/numerics/nonlinear.h (proposed by masterleinad; merged)
#15702: Fix doc typo (proposed by pcafrica; merged)
#15700: Instantiate CellAttachedData and CellAttachedDataSerializer (proposed by peterrum; merged)
#15699: Address more unnecessary calls to .c_str(). (proposed by bangerth; merged)
#15697: Fix incorrect subtitles and overloaded member functions in documentation (proposed by RichardYCJ; merged)
#15696: Minor updates to GridGenerator::hyper_cube_with_cylindrical_hole(). (proposed by bangerth; merged)
#15695: Minor doc update in manifold.cc. (proposed by bangerth; merged)
#15694: std::[io]fstream can now deal with std::string for filenames. (proposed by bangerth; merged)
#15689: Reorder vertices in the order in which we encounter them in cell loops. (proposed by bangerth)
#15688: Remove class VectorSpaceVector. (proposed by bangerth; merged)
#15687: Assert some basic mesh consistency notions. (proposed by bangerth; merged)
#15686: Make sure we always generate consistently oriented meshes. (proposed by bangerth; merged)
#15684: CMake: avoid "binding to none" for performance tests (proposed by tamiko; merged)
#15683: Make sure get_fe_by_name works for simplices. (proposed by luca-heltai; merged)
#15682: Replace use of C-style array by std::array. (proposed by bangerth; merged)
#15681: Update cmake variable documentation (proposed by gassmoeller; merged)
#15678: Fix face orientation (proposed by peterrum; merged)
#15677: KINSOL: allow for custom setup (proposed by sebproell; merged)
#15671: Avoid const return type in functions (proposed by masterleinad; merged)
#15667: Remove reference to VectorSpaceVector from ReadWriteVector's documentation. (proposed by bangerth; merged)
#15652: github: update linux runners (proposed by tamiko; merged)
#15610: bundle taskflow 3.6.0 (proposed by tjhei; merged)
#15576: Unified interface for serializing triangulations. (proposed by pcafrica; merged)
#15538: Use ArborX for spatial search in `guess_owners_of_entities()` (proposed by fdrmrc; merged)

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

#15742 Performance regression: various grid and particle operations gentoo-userland-clang-16 versus debian-bullseye-gcc-10 (opened)
#15741 Performance regression: timing-navier_stokes/setup_matrix_free (opened)
#15738 Can deal.ii include the finite difference method? (opened and closed)
#15733 Rethink deprecation of the <deal.II/base/std_cxx17/*> header files. (opened and closed)
#15732 Regression tester regressed 79ac9c (opened and closed)
#15728 Regression tester regressed 0847ac (opened and closed)
#15724 Compilation error with gcc-13.0.1/gcc-13.1.1 and bundled tbb (opened and closed)
#15714 dealii induces unnecessary dependencies (like OpenCascade, sundials) on its users when users are built as shared objects (opened and closed)
#15712 Warning in performance test step-68 (opened and closed)
#15710 Optimize product of symmetric tensors (opened)
#15703 `p::d::SolutionTransfer` for (de)serializing serial triangulations (opened)
#15701 Strategy with threading: Tasks, parallel for loops, etc (opened)
#15698 Regression tester regressed 629865 (opened and closed)
#15693 libdeal_II.so links with libX11.so? (opened and closed)
#15692 On FreeBSD with external Kokkos with openmp enabled: quicktest failures. (opened and closed)
#15691 Fixing the display problems of member functions of some classes in documentation (opened and closed)
#15690 CMake: should warn or indicate that DEAL_II_WITH_KOKKOS and DEAL_II_WITH_BOOST is always on. (opened)
#15685 Invalid cell connection generated between child cells (opened and closed)
#15680 Regression tester regressed c61d59 (opened and closed)
#14405 Potential deadlock in ConsensusAlgorithm::NBX on some systems (closed)
#8271 [Homepage] Update Survey results from 2016 (closed)
#8270 [Homepage] https://www.dealii.org/ideas.html (closed)
#3073 Remove VectorSpaceVector. (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.

Reply all
Reply to author
Forward
0 new messages