Hello everyone!

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

#9250: Update the discussion of HDF5 and R scripting in step-3. (proposed by 
bangerth) https://github.com/dealii/dealii/pull/9250

#9249: Replace Threads::mutex by std::mutex (proposed by masterleinad) 
https://github.com/dealii/dealii/pull/9249

#9248: Mark 'Possibilities for extensions' as <h3>. (proposed by bangerth) 
https://github.com/dealii/dealii/pull/9248

#9247: Fix description of a test. (proposed by bangerth) 
https://github.com/dealii/dealii/pull/9247

#9246: fixes a typo in function name. Replace make_grid_and_dofs() with just 
make_grid() (proposed by krishnakumarg1984) 
https://github.com/dealii/dealii/pull/9246

#9245: Document out of memory issues with 'make -jN'. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/9245

#9244: jenkins: increase OSX timeout (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/9244

#9242: replace some instances of Threads::Mutex with std::mutex (proposed by 
rezarastak) https://github.com/dealii/dealii/pull/9242

#9241: Mark some input arguments as 'const'. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/9241

#9240: Turn all for loops using "begin_active" into ranged-based ones (proposed 
by masterleinad) https://github.com/dealii/dealii/pull/9240

#9239: config.h: remove old p4est version logic (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/9239

#9238: Remove reference to the IA64 architecture. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/9238

#9237: make MueLu optional in Trilinos (proposed by tjhei) 
https://github.com/dealii/dealii/pull/9237

#9236: Augment the documentation of GridGenerator::simplex(). (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/9236

#9235: Augment the UMFPACK error message. (proposed by bangerth) 
https://github.com/dealii/dealii/pull/9235

#9234: doc: minor GridGenerator changes (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/9234

#9233: Remove cryptic comment (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/9233

#9231: Simpler CellwiseInverseMassMatrix::apply() function (proposed by 
kronbichler) https://github.com/dealii/dealii/pull/9231

#9230: Fix two bugs in matrix-free code (proposed by kronbichler; merged) 
https://github.com/dealii/dealii/pull/9230

#9229: Return error code from indent-all in check_indentation.sh (proposed by 
masterleinad; merged) https://github.com/dealii/dealii/pull/9229

#9228: fixes a typo in step-3 tutorial doc (convergence topic in 
results/extensions) (proposed by krishnakumarg1984) 
https://github.com/dealii/dealii/pull/9228

#9225: fix a doxygen citation (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/9225

#9224: Replace some DEAL_II_WITH_P4EST with DEAL_II_WITH_MPI (proposed by 
peterrum; merged) https://github.com/dealii/dealii/pull/9224

#9223: Bug fix in PR #9155 (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/9223

#9220: Test python bindings (proposed by masterleinad) 
https://github.com/dealii/dealii/pull/9220

#9219: deprecate members in TimerOutput (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/9219

#9218: Instantiate FETools::get_projection_matrix for float (proposed by 
peterrum; merged) https://github.com/dealii/dealii/pull/9218

#9217: Fix date in header (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/9217

#9216: Extend MatrixFree::get_dof_handler (proposed by Rombur) 
https://github.com/dealii/dealii/pull/9216

#9215: Make DoFHandlerPolicy independent of p4est  (proposed by peterrum; 
merged) https://github.com/dealii/dealii/pull/9215

#9214: Add CellId::is_ancestor_of (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/9214

#9211: Instantiate DoFTools::map_dofs_to_support_points() also for <1,3>. 
(proposed by bangerth; merged) https://github.com/dealii/dealii/pull/9211

#9210: Fix some doxygen namespace links. (proposed by drwells) 
https://github.com/dealii/dealii/pull/9210

#9209: Keep the 'dealii::' in 'using namespace dealii::'. (proposed by drwells; 
merged) https://github.com/dealii/dealii/pull/9209

#9208: Fix our TBB version check. (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/9208

#9207: Implement the solution of complex linear systems using UMFPACK. 
(proposed by bangerth) https://github.com/dealii/dealii/pull/9207

#9206: Provide TaskGroup::size(). (proposed by bangerth) 
https://github.com/dealii/dealii/pull/9206

#9205: Use a range-based for loop. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/9205

#9204: mu_parser functions modified to use std random number generators 
(proposed by rezarastak; merged) https://github.com/dealii/dealii/pull/9204

#9203: Simplify the code in a test a bit. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/9203

#9202: Mark a bunch of input arguments as 'const'. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/9202

#9201: Minor doc updates. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/9201

#9200: Fix what looks like an obvious typo in the UMFPACK source files. 
(proposed by bangerth; merged) https://github.com/dealii/dealii/pull/9200

#9199: Avoid _n and _m as variable names. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/9199

#9198: A sample code of advection-diffusion equation (proposed by 
saeedbahrami91) https://github.com/dealii/dealii/pull/9198

#9197: Let step-40 only depend on step-6, not step-17. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/9197

#9195: Create new dealii::Triangulation::create_triangulation() (proposed by 
peterrum) https://github.com/dealii/dealii/pull/9195

#9194: Label step-40 as a 'basic' tutorial program. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/9194

#9193: Let step-61 only build on step-51, not step-4. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/9193

#9191: silence system header MPI warning (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/9191

#9190: Annotate a few function arguments in doxygen. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/9190

#9189: Fix typo (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/9189

#9188: Include dof_accessor.h (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/9188

#9187: Specify namespace in precondition.h more precisely (proposed by 
masterleinad; merged) https://github.com/dealii/dealii/pull/9187

#9186: Avoid variable template in hp::Refinement (proposed by masterleinad; 
merged) https://github.com/dealii/dealii/pull/9186

#9185: Avoid warnings in tests (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/9185

#9183: Implement FE_Poly::memory_consumption  (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/9183

#9182: Deprecate some versions of DoFTools::extract_dofs(). (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/9182

#9181: ECL: specialize read/write operations [WIP] (proposed by peterrum) 
https://github.com/dealii/dealii/pull/9181

#9179: Add python interface for FunctionManifold (proposed by agrayver) 
https://github.com/dealii/dealii/pull/9179

#9178: Add a set of new python wrappers (proposed by agrayver) 
https://github.com/dealii/dealii/pull/9178

#9176: Remove unnecessary assignment (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/9176

#9175: Improve GridGenerator::channel_with_cylinder (proposed by kronbichler; 
merged) https://github.com/dealii/dealii/pull/9175

#9174: added default case for normal to mesh projection manifold (proposed by 
nicola-giuliani; merged) https://github.com/dealii/dealii/pull/9174

#9173: Fix particles/extract_index_set_01 (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/9173

#9172: Moved tests into their correct subdirectory. (proposed by luca-heltai; 
merged) https://github.com/dealii/dealii/pull/9172

#9171: Symbolic function. (proposed by luca-heltai) 
https://github.com/dealii/dealii/pull/9171

#9170: Fix formatting. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/9170

#9168: Contiguous tensor product IndexSet. (proposed by luca-heltai; merged) 
https://github.com/dealii/dealii/pull/9168

#9167: small documentation fix (proposed by rezarastak; merged) 
https://github.com/dealii/dealii/pull/9167

#9166: Fix narrowing conversions in tests (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/9166

#9165: Restrict a few more tests requiring complex values (proposed by 
masterleinad; merged) https://github.com/dealii/dealii/pull/9165

#9159: Update the results section of step-46. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/9159

#9157: Add field for inverse/projection of 1D polynomials to MF::ShapeInfo 
(proposed by kronbichler; merged) https://github.com/dealii/dealii/pull/9157

#9155: ECL: make mapping of neighbor available (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/9155

#9151: Introduced hp::Refinement::p_adaptivity_fixed_number(). (proposed by 
marcfehling; merged) https://github.com/dealii/dealii/pull/9151

#9148: Add a series of new python wrappers (proposed by agrayver; merged) 
https://github.com/dealii/dealii/pull/9148

#9147: Test matrix-free CUDA for float (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/9147

#9144: Add to FEInterfaceValues what we already have in FEValues. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/9144

#9125: Feature tensor function parser (proposed by konsim83; merged) 
https://github.com/dealii/dealii/pull/9125

#9106: Make pft independent of p4est (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/9106

#9074: Extract index sets from particle handlers (proposed by luca-heltai; 
merged) https://github.com/dealii/dealii/pull/9074

#9036: Adding a test for hp::DoFHandler and 
parallel::distributed::Triangulation  (proposed by BenBrands; merged) 
https://github.com/dealii/dealii/pull/9036


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

#9243: Spack build failed for v9.1.1 when building target obj_numerics_debug 
(opened) https://github.com/dealii/dealii/issues/9243

#9232: [Tutorial step-3] Request for python equivalent of possible extension 
("Using R and ggplot2 to generate PDFs with plots of the grid, the solution and 
convergence curves") (opened) https://github.com/dealii/dealii/issues/9232

#9227: [Step-3 tutorial] Invalid code for handling Neumann BCs along top and 
bottom faces (in suggested extensions) (opened) 
https://github.com/dealii/dealii/issues/9227

#9226: [documentation] Lack of clarity on simplex() function in the 
GridGenerator namespace (opened and closed) 
https://github.com/dealii/dealii/issues/9226

#9222: bibtex references broken on homepage (opened) 
https://github.com/dealii/dealii/issues/9222

#9221: MatrixFree ECL: face data by cells storage (opened) 
https://github.com/dealii/dealii/issues/9221

#9213: Perform coarsening with GridRefinement::refine_and_coarsen_optimize() 
(opened) https://github.com/dealii/dealii/issues/9213

#9212: Update TBB to use its latest CMake-based build system (opened) 
https://github.com/dealii/dealii/issues/9212

#9196: [documentation update needed] Step-1 tutorial still refers to old-style 
for loops for active cell iterators (opened and closed) 
https://github.com/dealii/dealii/issues/9196

#9192: Create/Load grid with local refinement (opened) 
https://github.com/dealii/dealii/issues/9192

#9184: Build of static library possibly broken (opened) 
https://github.com/dealii/dealii/issues/9184

#9180: LinearOperator on Trilinos using MPI (opened) 
https://github.com/dealii/dealii/issues/9180

#9177: FunctionParser still uses boost::random (opened and closed) 
https://github.com/dealii/dealii/issues/9177

#9169: CMake cannot find LAPACK (opened) 
https://github.com/dealii/dealii/issues/9169

#9164: Mismatch in vectorization capabilities (AVX) on i7-Comet Lake  (opened) 
https://github.com/dealii/dealii/issues/9164

#9163: Typo on Step-40's webpage (closed) 
https://github.com/dealii/dealii/issues/9163

#9102: FE_DGQ::memory_consumption() is not implmented (closed) 
https://github.com/dealii/dealii/issues/9102

#7023: Document steps to best visualize higher-order output in Paraview 
(closed) https://github.com/dealii/dealii/issues/7023

#5019: Directory structure for Particles/BoundingBoxes/etc. (closed) 
https://github.com/dealii/dealii/issues/5019


A list of all major changes since the last release can be found at 
https://www.dealii.org/developer/doxygen/deal.II/changes_after_8_5_0.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/5e14b998.1c69fb81.a5a4.00bfSMTPIN_ADDED_MISSING%40gmr-mx.google.com.

Reply via email to