deal.II Newsletter #107

26 views
Skip to first unread message

Rene Gassmoeller

unread,
Jan 21, 2020, 3:01:24 PM1/21/20
to dea...@googlegroups.com

Hello everyone!

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

#9411: Augment introduction to step-7. (proposed by bangerth)
#9410: Use std::to_string() instead of boost lexical_cast. (proposed by bangerth)
#9409: Update the documentation of int_to_string() and to_string(). (proposed by bangerth)
#9408: Clarify a channel limit. (proposed by drwells; merged)
#9407: make_flux_sparsity_pattern with flux couplings on a subset of the faces (proposed by simonsticko)
#9404: CI: disable cxx14 for the serial linux build (proposed by tjhei; merged)
#9403: add github actions OSX to readme (proposed by tjhei; merged)
#9402: Rename step-71 to step-47. (proposed by drwells)
#9401: Make channel limits consistent. (proposed by drwells; merged)
#9400: Utilities::to_string -> std::to_string (proposed by drwells; merged)
#9399: Fix compiling for C++11 (proposed by masterleinad; merged)
#9398: Fix 1D-bug in one version of make_flux_sparsity_pattern (proposed by simonsticko; merged)
#9397: Test indentation script on Mac OSX (proposed by masterleinad; merged)
#9394: fixes a tautology/word repetition in step-7 that was distracting (proposed by krishnakumarg1984; merged)
#9393: In step-7, removes the explicit listing of various norms since the list is anyway outdated (proposed by krishnakumarg1984)
#9391: Refactor settings of p:f:t [WIP] (proposed by peterrum)
#9389: Add assert to prevent floating point exception (proposed by peterrum; merged)
#9388: Implement GridGenerator::replicate_triangulation(). (proposed by drwells)
#9387: Noncontiguous distributed vector [WIP] (proposed by peterrum)
#9385: Fix tests using DataOut::active_cell_iterator (proposed by masterleinad; merged)
#9384: Fixes yet another redundancy in tutorial DAGs. (proposed by krishnakumarg1984)
#9382: Don't print lines connecting different parts of the legend. (proposed by bangerth; merged)
#9381: Fix the fill color for the tutorial graph legend. (proposed by bangerth; merged)
#9380: Replace !has_children() by is_active(). (proposed by bangerth; merged)
#9379: Simplifies the example code for glossary entries of boundary_id and manifold_id (proposed by krishnakumarg1984)
#9376: Read and write vtu files (proposed by luca-heltai)
#9375: Remove some redundant edges from tutorial DAG (proposed by krishnakumarg1984; merged)
#9373: remove unnecessary tutorial DAG edges (proposed by tjhei; merged)
#9372: Fix removing trailing whitespaces (proposed by masterleinad; merged)
#9371: New compress/decompress using gzip. (proposed by luca-heltai; merged)
#9370: More work on the tutorial graph (proposed by bangerth; merged)
#9367: fix documentation on add_table. Fixes 9355 (proposed by krishnakumarg1984)
#9366: In step-10, fixes explanation surrounding new header inclusion. fixes... (proposed by krishnakumarg1984; merged)
#9365: step-10 builds on step-7. see #9358 (proposed by krishnakumarg1984; merged)
#9364: Rename methods in ConsensusAlgorithmProcess (proposed by peterrum; merged)
#9362: New p:f:t tests (proposed by peterrum)
#9360: Host of documentation improvements to step-10 (proposed by krishnakumarg1984)
#9359: Work around a doxygen bug that triggers in step-10. (proposed by bangerth; merged)
#9352: Introduce CellAccessor::is_active(). (proposed by bangerth; merged)
#9351: Remove trailing whitespace (proposed by masterleinad; merged)
#9348: Fix typo in step-49 doc about gmsh (proposed by kronbichler; merged)
#9346: Fix input argument type of ExcFileNotOpen() (proposed by peterrum; merged)
#9345: Clarify comments about distort_random() in step-49. (proposed by bangerth; merged)
#9344: Talk about mesh quality in step-6. (proposed by bangerth; merged)
#9343: Compute diagonal with MatrixFree (proposed by peterrum)
#9342: Use the same color edges as for nodes in the tutorial graph. (proposed by bangerth; merged)
#9340: Lots of documentation fixes to Step-49 tutorial (proposed by krishnakumarg1984; merged)
#9339: Simplify the example code for setting manifold id in glossary using range-based for loop (proposed by krishnakumarg1984)
#9337: Fix some coverity complains (proposed by masterleinad; merged)
#9335: Simplify description in step-49. (proposed by bangerth; merged)
#9333: Use @pre instead of @note in a number of places. (proposed by bangerth; merged)
#9332: Add a changelog for step-71. (proposed by bangerth; merged)
#9331: Fix url to the gmsh website (proposed by krishnakumarg1984; merged)
#9330: In glossary for coarse_mesh, use monospace font for refine_global call since doxygen wasn't already hyperlinking it anyway (proposed by krishnakumarg1984; merged)
#9329: Better document an issue with curved boundaries. (proposed by bangerth; merged)
#9328: Fix the instantiations of GridOut::write_svg(). (proposed by bangerth; merged)
#9327: Better document gmsh's features. (proposed by bangerth; merged)
#9326: add alternative output for tests/base/utilities_pack_unpack_07 (proposed by tjhei; merged)
#9320: Simplifies the example codes for glossary entries of boundary_id and manifold_id (proposed by krishnakumarg1984)
#9318: converts l_2 to LaTeX code (proposed by krishnakumarg1984; merged)
#9300: In step 6 results doc, move the header file inclusion sentence to reflect that we need it for Sparse_ILU and not Jacobi preconditioner (proposed by krishnakumarg1984; merged)
#9297: Make GridTools::delete_duplicate_vertices() faster. (proposed by drwells; merged)
#9288: Update constraints documentation module to reflect recent updates to step-6 (proposed by krishnakumarg1984; merged)
#9287: Replace the Dataout::first_cell/next_cell() mechanism (proposed by bangerth; merged)
#9272: Make DoFTools::count_dofs_per_{component,block} return its data. (proposed by bangerth; merged)
#9259: Implement jump_hessian and jump_3rd_derivative on FEInterfaceValues. (proposed by simonsticko; merged)
#9249: Replace Threads::mutex by std::mutex (proposed by masterleinad; merged)
#9231: Simpler CellwiseInverseMassMatrix::apply() function (proposed by kronbichler; merged)
#9178: Add a set of new python wrappers (proposed by agrayver; merged)
#9111: step-71: the biharmonic equation. (proposed by bangerth; merged)
#9096: cleanup typedefs in DataOut (proposed by tamiko; merged)
#9075: Get set particle positions (proposed by luca-heltai; merged)
#9007: Add copy_triangulation to parallel::fullydistributed::Triangulation (proposed by peterrum; merged)

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

#9406 [Step-20] Reorganise prior tutorial contents since the input dependency for step-20 is incorrect/incomplete (opened)
#9405 Post-function in matrix-free cell_loop() is not executed correctly when not using AdditionalData::none (opened)
#9396 [Step-7] Violation of the philosophy of multiplying the test function from the left (opened and closed)
#9395 [Step-7] Improve/Clarify the introduction to the Helmholtz equation (opened and closed)
#9392 Documentation issues in VectorTools::NormType (opened and closed)
#9390 Refactor TriangulationDescription::Description (opened)
#9386 Improve "Possibilities for extension" of Step-7: discuss the method of manufactured solutions, use automatic differentiation for obtaining the source term, consistent initial and boundary conditions (opened)
#9383 Redundancy persists in tutorial DAG code-gallery edges (opened and closed)
#9378 In tutorials, mismatch between legend colour/shading and DAG nodes for code-gallery (opened and closed)
#9377 Remove connection between categories in legend for the tutorials DAG (opened and closed)
#9374 Steps 47, 58, 66-70 are missing? (opened and closed)
#9369 Native smoothing of grids respecting Manifolds (opened)
#9368 /contrib/utilties/indent script is broken for latest update of GNU sed (opened and closed)
#9363 Improve the documentation of ConsensusAlgorithm (opened)
#9361 Step-10 tutorial suddenly introduces Utilities::to_string without explanation (or comparison with std::string) (opened and closed)
#9358 [Step-10] Incomplete/incorrect input dependency in the tutorial dot diagram/DAG graph (opened and closed)
#9357 Weird doxygen behaviour for Step-10 documentation direct link to Plain Program in the browser (opened and closed)
#9356 [Step-10] Potentially need a documentation line explaining why the header file fe_nothing was introduced (opened and closed)
#9355 Potentially incomplete documentation for ConvergenceTable add_value() example (opened)
#9354 Use a consistent way to cite/reference papers in documentation (either inline full-text or bibtex cite keys) (opened and closed)
#9353 Possibility to account for material_id during p::fd::t creation (opened)
#9350 [Possible bug?] Conflict in the documentation of the different mapping classes (opened and closed)
#9349 [Step-49] Unclear documentation "using an object of class having an operator()" for GridTools::Transform (opened and closed)
#9347 Generalize Matrixfree::get_cell_iterator() (opened)
#9341 [Step-10] Remove long double from example step and improve discussion of round-off errors (opened)
#9338 Facilities to compute "goodness" of a mesh (i.e. a mesh-quality indicator) (opened and closed)
#9336 [Step-49 tutorial] Conflicting advice about unstructured mesh (random perturbations) (opened and closed)
#9334 [Step-49] Unclear wording on the Transform Operation used (opened and closed)
#9325 [Step-49] Consider including Gmsh's C++ API features (in addition to or replacing .geo file)? (opened and closed)
#9324 [Step-49] Documentation review: Gmsh capabilities need update? (opened and closed)
#9322 Incorrect pattern with one version of make_flux_sparsity_pattern (opened and closed)
#9319 Improve the example codes in the documentation module/glossary entry for boundary indicator id and manifold_id (opened)
#9299 Issue a sane error message when crashing for three-dimensional svg write attempts (closed)
#9296 [possible bug?] GridGenerator::hyper_ball does not produce circular edges at the boundary (closed)
#9279 URL links on the news page of dealii.org website do not work (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