deal.II Newsletter #195

18 views
Skip to first unread message

Rene Gassmoeller

unread,
Jan 3, 2022, 12:03:07 PM1/3/22
to dea...@googlegroups.com

Hello everyone!

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

#13161: Extend ScratchData's public interface with getter methods to access private data (proposed by jppelteret; merged)
#13160: step-74: add DOI (proposed by tjhei; merged)
#13159: Extend PreconditionRelaxation (proposed by peterrum)
#13158: Add get_embedding_dofs() to FE_Nedelec (2-D) (proposed by harmonj)
#13157: Avoid a temp array in the UMFPACK interfaces. (proposed by bangerth)
#13156: Also simplify parallel::accumulate_from_subranges() with lambdas. (proposed by bangerth)
#13155: Parallelize some functions setting up UMFPACK. (proposed by bangerth)
#13154: Iterator filter predicates for boundary and manifold IDs (proposed by jppelteret; merged)
#13153: Simplify more code in parallel.h via lambda functions. (proposed by bangerth; merged)
#13152: Refactor PreconditionRelaxation (proposed by peterrum)
#13151: Simplify code by using lambda functions. (proposed by bangerth; merged)
#13150: Avoid implicit bool conversions (proposed by masterleinad)
#13149: [WIP] Add Kokkos backend in LinearAlgebra::distributed::Vector (proposed by Rombur)
#13147: Add a bit of documentation to MPI::compute_point_to_point_communication_pattern() (proposed by bangerth)
#13146: Fix compilation with 64-bit integers (proposed by kronbichler; merged)
#13145: typo in docu of fourth order unit tensor (SymmetricTensor<4, dim, Number> identity_tensor()) (proposed by jfriedlein; merged)
#13144: Fix omissions in GridGenerator::flatten_triangulation(). (proposed by bangerth)
#13143: Bug in gmsh api writer. (proposed by luca-heltai)
#13142: Add a bunch of dummy functions for TriaAccessor<0,1,spacedim>. (proposed by bangerth; merged)
#13141: Add assertions and a test (proposed by bangerth)
#13140: Make sure HOME, WORKDIR, and MPI env vars are set correctly. (proposed by luca-heltai; merged)
#13139: Small cleanup in SD::BatchOptimizer (proposed by jppelteret; merged)
#13138: github-actions: cache Intel workflow (proposed by marcfehling; merged)
#13137: fix docker.yml - try 3 (proposed by marcfehling; merged)
#13136: Add a hash to SymEngine expression wrapper (proposed by jppelteret)
#13135: Add SD::BatchOptimizer::copy_from() function (proposed by jppelteret; merged)
#13134: Fix a bug in SD::BatchOptimizer::extract() (proposed by jppelteret; merged)
#13133: SD::BatchOptimizer: Corrected location for a set of assertions. (proposed by jppelteret; merged)
#13132: Add an assertion to GridGenerator::flatten_triangulation(). (proposed by bangerth; merged)
#13130: Update documentation of GridGenerator::flatten_triangulation(). (proposed by bangerth; merged)
#13129: CMake: use portable "rm" in quick_tests (proposed by tamiko; merged)
#13128: More minor changes to GridGenerator::flatten_triangulation(). (proposed by bangerth; merged)
#13125: fix docker.yml - try 2. (proposed by luca-heltai; merged)
#13124: Manifold for `pipe_junction`. (proposed by marcfehling)
#13123: [9.3] sundials fix (proposed by tjhei; merged)
#13121: Calculate cross product once. (proposed by marcfehling; merged)
#13120: Add docker image with root user. (proposed by luca-heltai; merged)
#13119: Minor doc update in the cmake system. (proposed by bangerth; merged)
#13118: Separate 2d povray output from the general case. (proposed by bangerth; merged)
#13117: Minor rework of the GridGenerator::flatten_triangulation() function. (proposed by bangerth; merged)
#13116: Deprecate the new_thread() functions. (proposed by bangerth; merged)
#13115: MatrixFree: fix size of vector (proposed by peterrum; merged)
#13112: Add a necessary include file. (proposed by bangerth; merged)
#13111: Link from step-47 to step-82. (proposed by bangerth; merged)
#13109: Simplify initialization of block objects in the tutorial. (proposed by bangerth; merged)
#13108: Omit unnecessary template argument. (proposed by bangerth; merged)
#13107: Make sure doxygen does not format all combinations of NonMatching::coupling_*. (proposed by luca-heltai; merged)
#13105: Allow inhomogeneous Dirichlet in Step-60 (proposed by fdrmrc; merged)
#13102: Correct typo (math rendering) (proposed by mwichro; merged)
#13101: Bug fix of MF face eval for hanging nodes and non-standard orientation (proposed by kronbichler; merged)
#13099: Global coarsening: compress weights (proposed by peterrum; merged)
#13097: Util::MPI::compute_n_point_to_point_communications() add fallback (proposed by peterrum; merged)
#13095: Fixed bug in SparseDirectUMFPACK #12916 (proposed by kuljitvirk; merged)
#13093: Remove a redundant argument to xargs. (proposed by drwells; merged)
#13080: Minor doc changes to the consensus algorithms (proposed by bangerth; merged)
#13079: Evaluation kernels: Avoid checking the orientations in inner loop (proposed by kronbichler; merged)
#13012: Start from zero vector for MG coarse solver (proposed by kronbichler; merged)
#11358: CI: select 64bit windows platform (proposed by tjhei; merged)

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

#13148 Better document consensus algorithms (opened)
#13131 GridGenerator::flatten_triangulation() says that it only works for triangulations without hanging nodes... (opened and closed)
#13127 GridGenerator::flatten_triangulation() does not copy data on boundary edges in 3d (opened)
#13126 GridGenerator::flatten_triangulation() does not copy manifold ids of internal objects (opened and closed)
#13122 CMake custom target command contains `rm`, which is not available under windows. (opened and closed)
#13114 simplex/conv_hex_to_simplex_02 fails with gcc 11.2 (opened)
#13113 Portable refined triangulation format (opened)
#13110 Modernize a small aspect of step-20/21 (opened)
#13106 `FindBoost.cmake` warnings (opened and closed)
#13104 Problem with BOOST_SERIALIZATION_USABLE (opened and closed)
#13103 Names of FEInterfaceValues functions (opened)
#13100 PETSc object is in wrong state (closed)
#13089 Fix indent script warnings (closed)
#13074 Failure in ConsensusAlgorithms::NBX::answer_requests() (closed)
#13052 Warnings in data_out_base.cc (closed)
#13034 Wrong .prm files in step-60 (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