deal.II Newsletter #105

29 views
Skip to first unread message

Rene Gassmoeller

unread,
Jan 7, 2020, 12:02:18 PM1/7/20
to dea...@googlegroups.com

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)
#9249: Replace Threads::mutex by std::mutex (proposed by masterleinad)
#9248: Mark 'Possibilities for extensions' as

. (proposed by bangerth)
#9247: Fix description of a test. (proposed by bangerth)
#9246: fixes a typo in function name. Replace make_grid_and_dofs() with just make_grid() (proposed by krishnakumarg1984)
#9245: Document out of memory issues with 'make -jN'. (proposed by bangerth; merged)
#9244: jenkins: increase OSX timeout (proposed by tjhei; merged)
#9242: replace some instances of Threads::Mutex with std::mutex (proposed by rezarastak)
#9241: Mark some input arguments as 'const'. (proposed by bangerth; merged)
#9240: Turn all for loops using "begin_active" into ranged-based ones (proposed by masterleinad)
#9239: config.h: remove old p4est version logic (proposed by tjhei; merged)
#9238: Remove reference to the IA64 architecture. (proposed by bangerth; merged)
#9237: make MueLu optional in Trilinos (proposed by tjhei)
#9236: Augment the documentation of GridGenerator::simplex(). (proposed by bangerth; merged)
#9235: Augment the UMFPACK error message. (proposed by bangerth)
#9234: doc: minor GridGenerator changes (proposed by tjhei; merged)
#9233: Remove cryptic comment (proposed by masterleinad; merged)
#9231: Simpler CellwiseInverseMassMatrix::apply() function (proposed by kronbichler)
#9230: Fix two bugs in matrix-free code (proposed by kronbichler; merged)
#9229: Return error code from indent-all in check_indentation.sh (proposed by masterleinad; merged)
#9228: fixes a typo in step-3 tutorial doc (convergence topic in results/extensions) (proposed by krishnakumarg1984)
#9225: fix a doxygen citation (proposed by tjhei; merged)
#9224: Replace some DEAL_II_WITH_P4EST with DEAL_II_WITH_MPI (proposed by peterrum; merged)
#9223: Bug fix in PR #9155 (proposed by peterrum; merged)
#9220: Test python bindings (proposed by masterleinad)
#9219: deprecate members in TimerOutput (proposed by tjhei; merged)
#9218: Instantiate FETools::get_projection_matrix for float (proposed by peterrum; merged)
#9217: Fix date in header (proposed by peterrum; merged)
#9216: Extend MatrixFree::get_dof_handler (proposed by Rombur)
#9215: Make DoFHandlerPolicy independent of p4est (proposed by peterrum; merged)
#9214: Add CellId::is_ancestor_of (proposed by peterrum; merged)
#9211: Instantiate DoFTools::map_dofs_to_support_points() also for <1,3>. (proposed by bangerth; merged)
#9210: Fix some doxygen namespace links. (proposed by drwells)
#9209: Keep the 'dealii::' in 'using namespace dealii::'. (proposed by drwells; merged)
#9208: Fix our TBB version check. (proposed by drwells; merged)
#9207: Implement the solution of complex linear systems using UMFPACK. (proposed by bangerth)
#9206: Provide TaskGroup::size(). (proposed by bangerth)
#9205: Use a range-based for loop. (proposed by bangerth; merged)
#9204: mu_parser functions modified to use std random number generators (proposed by rezarastak; merged)
#9203: Simplify the code in a test a bit. (proposed by bangerth; merged)
#9202: Mark a bunch of input arguments as 'const'. (proposed by bangerth; merged)
#9201: Minor doc updates. (proposed by bangerth; merged)
#9200: Fix what looks like an obvious typo in the UMFPACK source files. (proposed by bangerth; merged)
#9199: Avoid _n and _m as variable names. (proposed by bangerth; merged)
#9198: A sample code of advection-diffusion equation (proposed by saeedbahrami91)
#9197: Let step-40 only depend on step-6, not step-17. (proposed by bangerth; merged)
#9195: Create new dealii::Triangulation::create_triangulation() (proposed by peterrum)
#9194: Label step-40 as a 'basic' tutorial program. (proposed by bangerth; merged)
#9193: Let step-61 only build on step-51, not step-4. (proposed by bangerth; merged)
#9191: silence system header MPI warning (proposed by tjhei; merged)
#9190: Annotate a few function arguments in doxygen. (proposed by bangerth; merged)
#9189: Fix typo (proposed by peterrum; merged)
#9188: Include dof_accessor.h (proposed by peterrum; merged)
#9187: Specify namespace in precondition.h more precisely (proposed by masterleinad; merged)
#9186: Avoid variable template in hp::Refinement (proposed by masterleinad; merged)
#9185: Avoid warnings in tests (proposed by masterleinad; merged)
#9183: Implement FE_Poly::memory_consumption (proposed by peterrum; merged)
#9182: Deprecate some versions of DoFTools::extract_dofs(). (proposed by bangerth; merged)
#9181: ECL: specialize read/write operations [WIP] (proposed by peterrum)
#9179: Add python interface for FunctionManifold (proposed by agrayver)
#9178: Add a set of new python wrappers (proposed by agrayver)
#9176: Remove unnecessary assignment (proposed by peterrum; merged)
#9175: Improve GridGenerator::channel_with_cylinder (proposed by kronbichler; merged)
#9174: added default case for normal to mesh projection manifold (proposed by nicola-giuliani; merged)
#9173: Fix particles/extract_index_set_01 (proposed by masterleinad; merged)
#9172: Moved tests into their correct subdirectory. (proposed by luca-heltai; merged)
#9171: Symbolic function. (proposed by luca-heltai)
#9170: Fix formatting. (proposed by bangerth; merged)
#9168: Contiguous tensor product IndexSet. (proposed by luca-heltai; merged)
#9167: small documentation fix (proposed by rezarastak; merged)
#9166: Fix narrowing conversions in tests (proposed by masterleinad; merged)
#9165: Restrict a few more tests requiring complex values (proposed by masterleinad; merged)
#9159: Update the results section of step-46. (proposed by bangerth; merged)
#9157: Add field for inverse/projection of 1D polynomials to MF::ShapeInfo (proposed by kronbichler; merged)
#9155: ECL: make mapping of neighbor available (proposed by peterrum; merged)
#9151: Introduced hp::Refinement::p_adaptivity_fixed_number(). (proposed by marcfehling; merged)
#9148: Add a series of new python wrappers (proposed by agrayver; merged)
#9147: Test matrix-free CUDA for float (proposed by masterleinad; merged)
#9144: Add to FEInterfaceValues what we already have in FEValues. (proposed by bangerth; merged)
#9125: Feature tensor function parser (proposed by konsim83; merged)
#9106: Make pft independent of p4est (proposed by peterrum; merged)
#9074: Extract index sets from particle handlers (proposed by luca-heltai; merged)
#9036: Adding a test for hp::DoFHandler and parallel::distributed::Triangulation (proposed by BenBrands; merged)

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)
#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)
#9227 [Step-3 tutorial] Invalid code for handling Neumann BCs along top and bottom faces (in suggested extensions) (opened)
#9226 [documentation] Lack of clarity on simplex() function in the GridGenerator namespace (opened and closed)
#9222 bibtex references broken on homepage (opened)
#9221 MatrixFree ECL: face data by cells storage (opened)
#9213 Perform coarsening with GridRefinement::refine_and_coarsen_optimize() (opened)
#9212 Update TBB to use its latest CMake-based build system (opened)
#9196 [documentation update needed] Step-1 tutorial still refers to old-style for loops for active cell iterators (opened and closed)
#9192 Create/Load grid with local refinement (opened)
#9184 Build of static library possibly broken (opened)
#9180 LinearOperator on Trilinos using MPI (opened)
#9177 FunctionParser still uses boost::random (opened and closed)
#9169 CMake cannot find LAPACK (opened)
#9164 Mismatch in vectorization capabilities (AVX) on i7-Comet Lake (opened)
#9163 Typo on Step-40's webpage (closed)
#9102 FE_DGQ::memory_consumption() is not implmented (closed)
#7023 Document steps to best visualize higher-order output in Paraview (closed)
#5019 Directory structure for Particles/BoundingBoxes/etc. (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