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) 
https://github.com/dealii/dealii/pull/13161

#13160: step-74: add DOI (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/13160

#13159: Extend PreconditionRelaxation (proposed by peterrum) 
https://github.com/dealii/dealii/pull/13159

#13158: Add get_embedding_dofs() to FE_Nedelec (2-D) (proposed by harmonj) 
https://github.com/dealii/dealii/pull/13158

#13157: Avoid a temp array in the UMFPACK interfaces. (proposed by bangerth) 
https://github.com/dealii/dealii/pull/13157

#13156: Also simplify parallel::accumulate_from_subranges() with lambdas. 
(proposed by bangerth) https://github.com/dealii/dealii/pull/13156

#13155: Parallelize some functions setting up UMFPACK. (proposed by bangerth) 
https://github.com/dealii/dealii/pull/13155

#13154: Iterator filter predicates for boundary and manifold IDs (proposed by 
jppelteret; merged) https://github.com/dealii/dealii/pull/13154

#13153: Simplify more code in parallel.h via lambda functions. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/13153

#13152: Refactor PreconditionRelaxation (proposed by peterrum) 
https://github.com/dealii/dealii/pull/13152

#13151: Simplify code by using lambda functions. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/13151

#13150: Avoid implicit bool conversions (proposed by masterleinad) 
https://github.com/dealii/dealii/pull/13150

#13149: [WIP] Add Kokkos backend in LinearAlgebra::distributed::Vector 
(proposed by Rombur) https://github.com/dealii/dealii/pull/13149

#13147: Add a bit of documentation to 
MPI::compute_point_to_point_communication_pattern() (proposed by bangerth) 
https://github.com/dealii/dealii/pull/13147

#13146: Fix compilation with 64-bit integers (proposed by kronbichler; merged) 
https://github.com/dealii/dealii/pull/13146

#13145: typo in docu of fourth order unit tensor (SymmetricTensor<4, dim, 
Number> identity_tensor()) (proposed by jfriedlein; merged) 
https://github.com/dealii/dealii/pull/13145

#13144: Fix omissions in GridGenerator::flatten_triangulation(). (proposed by 
bangerth) https://github.com/dealii/dealii/pull/13144

#13143: Bug in gmsh api writer. (proposed by luca-heltai) 
https://github.com/dealii/dealii/pull/13143

#13142: Add a bunch of dummy functions for TriaAccessor<0,1,spacedim>. 
(proposed by bangerth; merged) https://github.com/dealii/dealii/pull/13142

#13141: Add assertions and a test (proposed by bangerth) 
https://github.com/dealii/dealii/pull/13141

#13140: Make sure HOME, WORKDIR, and MPI env vars are set correctly. (proposed 
by luca-heltai; merged) https://github.com/dealii/dealii/pull/13140

#13139: Small cleanup in SD::BatchOptimizer (proposed by jppelteret; merged) 
https://github.com/dealii/dealii/pull/13139

#13138: github-actions: cache Intel workflow (proposed by marcfehling; merged) 
https://github.com/dealii/dealii/pull/13138

#13137: fix docker.yml - try 3 (proposed by marcfehling; merged) 
https://github.com/dealii/dealii/pull/13137

#13136: Add a hash to SymEngine expression wrapper (proposed by jppelteret) 
https://github.com/dealii/dealii/pull/13136

#13135: Add SD::BatchOptimizer::copy_from() function (proposed by jppelteret; 
merged) https://github.com/dealii/dealii/pull/13135

#13134: Fix a bug in SD::BatchOptimizer::extract() (proposed by jppelteret; 
merged) https://github.com/dealii/dealii/pull/13134

#13133: SD::BatchOptimizer: Corrected location for a set of assertions. 
(proposed by jppelteret; merged) https://github.com/dealii/dealii/pull/13133

#13132: Add an assertion to GridGenerator::flatten_triangulation(). (proposed 
by bangerth; merged) https://github.com/dealii/dealii/pull/13132

#13130: Update documentation of GridGenerator::flatten_triangulation(). 
(proposed by bangerth; merged) https://github.com/dealii/dealii/pull/13130

#13129: CMake: use portable "rm" in quick_tests (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/13129

#13128: More minor changes to GridGenerator::flatten_triangulation(). (proposed 
by bangerth; merged) https://github.com/dealii/dealii/pull/13128

#13125: fix docker.yml - try 2. (proposed by luca-heltai; merged) 
https://github.com/dealii/dealii/pull/13125

#13124: Manifold for `pipe_junction`. (proposed by marcfehling) 
https://github.com/dealii/dealii/pull/13124

#13123: [9.3] sundials fix (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/13123

#13121: Calculate cross product once. (proposed by marcfehling; merged) 
https://github.com/dealii/dealii/pull/13121

#13120: Add docker image with root user. (proposed by luca-heltai; merged) 
https://github.com/dealii/dealii/pull/13120

#13119: Minor doc update in the cmake system. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/13119

#13118: Separate 2d povray output from the general case. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/13118

#13117: Minor rework of the GridGenerator::flatten_triangulation() function. 
(proposed by bangerth; merged) https://github.com/dealii/dealii/pull/13117

#13116: Deprecate the new_thread() functions. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/13116

#13115: MatrixFree: fix size of vector (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/13115

#13112: Add a necessary include file. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/13112

#13111: Link from step-47 to step-82. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/13111

#13109: Simplify initialization of block objects in the tutorial. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/13109

#13108: Omit unnecessary template argument. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/13108

#13107: Make sure doxygen does not format all combinations of 
NonMatching::coupling_*. (proposed by luca-heltai; merged) 
https://github.com/dealii/dealii/pull/13107

#13105: Allow inhomogeneous Dirichlet in Step-60 (proposed by fdrmrc; merged) 
https://github.com/dealii/dealii/pull/13105

#13102: Correct typo (math rendering) (proposed by mwichro; merged) 
https://github.com/dealii/dealii/pull/13102

#13101: Bug fix of MF face eval for hanging nodes and non-standard orientation 
(proposed by kronbichler; merged) https://github.com/dealii/dealii/pull/13101

#13099: Global coarsening: compress weights (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/13099

#13097: Util::MPI::compute_n_point_to_point_communications() add fallback 
(proposed by peterrum; merged) https://github.com/dealii/dealii/pull/13097

#13095: Fixed bug in SparseDirectUMFPACK #12916 (proposed by kuljitvirk; 
merged) https://github.com/dealii/dealii/pull/13095

#13093: Remove a redundant argument to xargs. (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/13093

#13080: Minor doc changes to the consensus algorithms (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/13080

#13079: Evaluation kernels: Avoid checking the orientations in inner loop 
(proposed by kronbichler; merged) https://github.com/dealii/dealii/pull/13079

#13012: Start from zero vector for MG coarse solver (proposed by kronbichler; 
merged) https://github.com/dealii/dealii/pull/13012

#11358: CI: select 64bit windows platform (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/11358


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

#13148: Better document consensus algorithms (opened) 
https://github.com/dealii/dealii/issues/13148

#13131: GridGenerator::flatten_triangulation() says that it only works for 
triangulations without hanging nodes... (opened and closed) 
https://github.com/dealii/dealii/issues/13131

#13127: GridGenerator::flatten_triangulation() does not copy data on boundary 
edges in 3d (opened) https://github.com/dealii/dealii/issues/13127

#13126: GridGenerator::flatten_triangulation() does not copy manifold ids of 
internal objects (opened and closed) 
https://github.com/dealii/dealii/issues/13126

#13122: CMake custom target command contains `rm`, which is not available under 
windows. (opened and closed) https://github.com/dealii/dealii/issues/13122

#13114: simplex/conv_hex_to_simplex_02 fails with gcc 11.2 (opened) 
https://github.com/dealii/dealii/issues/13114

#13113: Portable refined triangulation format (opened) 
https://github.com/dealii/dealii/issues/13113

#13110: Modernize a small aspect of step-20/21 (opened) 
https://github.com/dealii/dealii/issues/13110

#13106: `FindBoost.cmake` warnings (opened and closed) 
https://github.com/dealii/dealii/issues/13106

#13104: Problem with BOOST_SERIALIZATION_USABLE (opened and closed) 
https://github.com/dealii/dealii/issues/13104

#13103: Names of FEInterfaceValues functions (opened) 
https://github.com/dealii/dealii/issues/13103

#13100: PETSc object is in wrong state (closed) 
https://github.com/dealii/dealii/issues/13100

#13089: Fix indent script warnings (closed) 
https://github.com/dealii/dealii/issues/13089

#13074: Failure in ConsensusAlgorithms::NBX<T1, T2>::answer_requests() (closed) 
https://github.com/dealii/dealii/issues/13074

#13052: Warnings in data_out_base.cc (closed) 
https://github.com/dealii/dealii/issues/13052

#13034: Wrong .prm files in step-60 (closed) 
https://github.com/dealii/dealii/issues/13034


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/61d32c49.1c69fb81.9c308.c6f7SMTPIN_ADDED_MISSING%40gmr-mx.google.com.

Reply via email to