deal.II Newsletter #120

66 views
Skip to first unread message

Rene Gassmoeller

unread,
May 29, 2020, 3:06:47 PM5/29/20
to dea...@googlegroups.com

Hello everyone!

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

#10420: Delete copy constructor for ThreadLocalStorage (proposed by masterleinad)
#10419: Change planarity tolerance in measure() for quads (proposed by AndKyr)
#10418: tests: remove .with_threads (proposed by tjhei)
#10417: Add inter-grid transfer operators (proposed by peterrum)
#10416: Remove author information from source files (proposed by masterleinad)
#10415: Fix compiling with gcc with C++20 (proposed by masterleinad; merged)
#10413: use DEAL_II_WITH_TBB instead of DEAL_II_WITH_THREADS (proposed by tjhei; merged)
#10412: Run operations sequentially in Threads::Task when n_threads==1. (proposed by bangerth)
#10411: remove logstream DEAL_II_WITH_THREADS logic (proposed by tjhei; merged)
#10410: provide Thread also without TBB (proposed by tjhei; merged)
#10409: add cpp-taskflow quicktest (proposed by tjhei)
#10408: Update step 28 (proposed by drwells; merged)
#10407: Remove a duplicated comment. (proposed by bangerth; merged)
#10406: Get rid of the TBB header files. (proposed by bangerth; merged)
#10405: move tests related to multithreading into tests/multithreading/ (proposed by tjhei; merged)
#10404: initialize cpp-taskflow (proposed by tjhei; merged)
#10403: Fix warning about missing copy constructors (proposed by masterleinad; merged)
#10402: Remove pointers of pointers in FEEvaluation (proposed by kronbichler)
#10399: Remove references to hp::DoFHandler in DoFAccessor. (proposed by drwells)
#10398: Deprecate some PETSc things not available in other classes (proposed by drwells; merged)
#10397: Use C++14 lambda capture in step-69. (proposed by bangerth)
#10396: Augment a test to also check sparse vanka. (proposed by drwells; merged)
#10395: Deprecate vanka threads (proposed by drwells; merged)
#10394: Step-73: Finite strain elasticity using automatic differentiation (proposed by jppelteret)
#10393: Step-72: The minimal surface equation using automatic differentiation (step-15 revisited) (proposed by jppelteret)
#10392: Step-71: Introduction to automatic and symbolic differentiation (proposed by jppelteret)
#10390: Add particle property output (proposed by gassmoeller; merged)
#10389: Rewrite the Threads::Task class using C++11 features. (proposed by bangerth; merged)
#10387: Remove our deprecated netcdf bindings (proposed by drwells; merged)
#10386: Remove our deprecated nanoflann bindings (proposed by drwells; merged)
#10385: fix doxygen export of DEAL_II_WITH_TBB/CPP_TASKFLOW (proposed by tjhei; merged)
#10384: export "DEAL_II_WITH_THREADS" in deal.IIConfig.cmake (proposed by tamiko; merged)
#10383: [CI] github actions do not check indent (proposed by tjhei; merged)
#10382: adjust TBB initialization (proposed by tjhei; merged)
#10380: Find correct FindBoost.cmake on case-insensitive fs (proposed by MarcusCalhoun-Lopez; merged)
#10379: Simplify C++14 lambda initializers (proposed by masterleinad; merged)
#10378: Remove Task::operator==. (proposed by bangerth; merged)
#10377: Improve documentation of Threads::Task. (proposed by bangerth; merged)
#10376: Krishna fix redundant edge step50 (proposed by krishnakumarg1984)
#10375: removes an unnecessary edge in tutorial dependency graph (proposed by krishnakumarg1984; merged)
#10374: Better document Threads::internal::return_value. (proposed by bangerth)
#10373: Move member functions of an internal class outside the class declaration (proposed by bangerth; merged)
#10372: Route all variations of Threads::new_task() through one instance. (proposed by bangerth; merged)
#10371: Better document Threads::new_task. (proposed by bangerth; merged)
#10369: matrix-free: do not use bool args (proposed by tjhei)
#10368: Hook in videos of second-order results for step-69. (proposed by bangerth; merged)
#10367: Compile MSVC testers with warnings as errors (proposed by masterleinad; merged)
#10364: Move template definitions from hdf5.cc to hdf5.h (proposed by dangars)
#10363: GridTools::Cache::get_locally_owned_cell_bounding_boxes_rtree() (proposed by luca-heltai)
#10362: Add particle handler signal particle_lost (proposed by gassmoeller; merged)
#10361: Petsc vector space vector (proposed by drwells)
#10360: Fix compiling with clang-10 with C++20 support (proposed by masterleinad; merged)
#10359: Fix warning in set_bit (proposed by peterrum; merged)
#10357: Add missing docu to GeometryInfo (proposed by peterrum; merged)
#10356: CMake: Refactor C++17 bessel function support into separate check (proposed by tamiko; merged)
#10355: Use @cite style for references in step-70. (proposed by bangerth; merged)
#10354: More cxx14 docs (proposed by drwells; merged)
#10353: Avoid overloaded operator ambiguity with -std=c++20 and clang-10 (proposed by tamiko)
#10352: Ensure that a test is only run when its dependencies are satisfied. (proposed by bangerth; merged)
#10348: Applied user constraints after prolongation and restriction (proposed by mathmerizing)
#10347: CMake: Record C++ standard support level in detailed.log (proposed by tamiko; merged)
#10346: CMake: Fix C++17/20 detection (proposed by tamiko; merged)
#10345: Fix 64-bit compilation. (proposed by bangerth; merged)
#10344: C++14 updates to a couple of tutorials. (proposed by bangerth; merged)
#10343: Applying user constraints after prolongation and restriction in MG (proposed by mathmerizing)
#10342: Fix compilation with -std=c++20 (proposed by tamiko)
#10341: CMake: Bugfix: Run symbol check (using C compiler) without CXXFLAGS (proposed by tamiko; merged)
#10338: C++14 cleanup part 1: deprecate headers, do not use wrapper namespace (proposed by tamiko; merged)
#10337: pack_rtree_of_indices(). (proposed by luca-heltai; merged)
#10336: Remove redundant instantiation of ShapeInfo (proposed by peterrum; merged)
#10335: consistently use local_size(). (proposed by drwells)
#10334: Split up MatrixFree::initialize_indices to speed up compilation (proposed by kronbichler)
#10332: Correct documentation of a MatrixFree additional data parameter (proposed by kronbichler; merged)
#10329: Remove template arguments from internal data structures of Triangulation (proposed by peterrum; merged)
#10328: Merge DoFHandler and hp::DoFHandler (proposed by peterrum)
#10327: CMake: decouple thread setup, add taskflow library (proposed by tamiko; merged)
#10326: Orientation rotation flip (proposed by peterrum; merged)
#10325: Generalize vertex/line/quad_index (proposed by peterrum; merged)
#10324: CMake cleanup (proposed by tamiko; merged)
#10323: Remove gcc 4.7 workaround (proposed by tjhei; merged)
#10322: cuda: deprecate atomicAdd_wrapper (proposed by tjhei; merged)
#10320: Update ParticleHandler::n_particles_in_cell(). (proposed by bangerth; merged)
#10319: Add a version of ParticleAccessor::set_properties(). (proposed by bangerth; merged)
#10318: Use 'override' on overridden member functions in the documentation. (proposed by bangerth; merged)
#10317: remove const from static_cast (proposed by tjhei; merged)
#10316: Update doc for VTKFlags::write_higher_order_cells. (proposed by marcfehling; merged)
#10315: remove deprecated dealii::Thread classes and functions (proposed by tamiko; merged)
#10313: Move a class out of a surrounding class. (proposed by bangerth; merged)
#10312: CI: github actions windows: CMakeError.log (proposed by tjhei; merged)
#10309: Bugfix: hp::Refinement::choose_p_over_h() in parallel (proposed by marcfehling; merged)
#10308: Step-68 : Particle tracking of a massless tracer in a vortical flow (proposed by blaisb)
#10307: Require C++14, massive CMake cleanup (proposed by tamiko; merged)
#10306: Rename namespace internals:: to internal::AffineConstraints::. (proposed by bangerth; merged)
#10305: step-70: Rewrite the motivation for particles. (proposed by bangerth; merged)
#10303: Fix a missing space in an error message. (proposed by bangerth; merged)
#10302: Default the second template argument of Particles::DataOut. (proposed by bangerth; merged)
#10301: step-19: A simple particles tutorial. (proposed by bangerth)
#10300: Fix a missing mapping argument (proposed by gassmoeller; merged)
#10299: Refactor GridTools::DistributedComputePointLocations (proposed by gassmoeller; merged)
#10298: remove cuda 8 support (proposed by tjhei; merged)
#10297: Remove C++11 compatibility headers. (proposed by drwells; merged)
#10294: Random doc improvements. (proposed by bangerth; merged)
#10293: Master doxygen fixes (proposed by tjhei; merged)
#10292: [9.2] fix step-69 doxygen formula (proposed by tjhei; merged)
#10291: [9.2] fix step-70 doxygen formula (proposed by tjhei; merged)
#10290: Take over #10289 contrib/python_wrapper: set environment correctly (proposed by tamiko; merged)
#10289: contrib/python_wrapper: set environment correctly (proposed by tamiko; merged)
#10288: Take over #10280 (proposed by tamiko; merged)
#10287: Remove lapack_templates.h from more public headers. (proposed by drwells; merged)
#10286: Move implementation of CellData to the correct file (proposed by peterrum; merged)
#10285: ThreadLocalStorage: Reimplement using STL C++14 functionality (proposed by tamiko; merged)
#10283: fix bug in symmetric tensor unrolled_to_component_indices function. (proposed by MFraters; merged)
#10282: BoundingBoxDataOut (proposed by luca-heltai; merged)
#10280: Link in step-70 pictures and videos. (proposed by bangerth; merged)
#10279: [9.2] Take over #10275 (proposed by tamiko; merged)
#10278: [9.2] Take over #10272 (proposed by tamiko; merged)
#10277: [9.2] Take over #10271: step-70: add missing compress() call (proposed by drwells; merged)
#10276: [9.2] Take over #10269: fix PETSc step-70 compilation (proposed by masterleinad; merged)
#10275: More updates to step-70 (proposed by bangerth; merged)
#10274: Fixed parameters for step-70. (proposed by luca-heltai; merged)
#10272: step-70: remove unused variable (proposed by tjhei; merged)
#10271: step-70: add missing compress() call (proposed by tjhei; merged)
#10269: fix PETSc step-70 compilation (proposed by tjhei; merged)
#10268: Simplify get_dof_indices() and set_dof_indices() (proposed by peterrum; merged)
#10267: [9.2.] Take over #10266 (proposed by tamiko; merged)
#10266: Fix python test with input file (proposed by masterleinad; merged)
#10265: [9.2] Take over #10259 (proposed by tamiko; merged)
#10264: [9.2] Take over #10257 (proposed by tamiko; merged)
#10261: [9.2] Take over #10256: arpack/step-36_ar_with_iterations: Remove iteration count (proposed by masterleinad; merged)
#10260: [9.2] Takeover #10258: Fix some tests failing without LAPAPCK support and with -Werror (proposed by masterleinad; merged)
#10259: Edits for step-70.cc (proposed by bangerth; merged)
#10258: Fix some tests failing without LAPACK support and with -Werror (proposed by masterleinad; merged)
#10257: sacado/helper_scalar_coupled_3_components_01_4: avoid race condition (proposed by tamiko; merged)
#10256: arpack/step-36_ar_with_iterations: Remove iteration count (proposed by tamiko; merged)
#10254: [9.2] Take over #10249 (proposed by tamiko; merged)
#10253: Fix doxygen underscores. (proposed by drwells)
#10252: [9.2] Take over #10237 and #10244 (proposed by tamiko; merged)
#10251: [9.2] Take over #10241, #10242, #10245 (proposed by tamiko; merged)
#10250: [9.2] Take over #10232 (proposed by tamiko; merged)
#10249: Workaround: Add additional complex ProductTypeImpl specializations (proposed by tamiko; merged)
#10248: [9.2] Take over 10228: Fix warning in step70 (proposed by masterleinad; merged)
#10247: [9.2] Take over #10235: Specialize BoundingBox<0> to prevent instantiating BoundingBox<-1>. (proposed by masterleinad; merged)
#10245: update copyright years (proposed by tjhei; merged)
#10244: Edits to introduction and results section of step-70 (proposed by bangerth; merged)
#10242: Fixed a few copyright years manually. (proposed by marcfehling; merged)
#10241: fix update-copyright not going 2 levels deep into src/include (proposed by tjhei; merged)
#10238: [9.2] takeover #10236 (proposed by drwells; merged)
#10237: Improve spelling in step-70. (proposed by drwells; merged)
#10236: Use std_cxx14::make_unique in step-70. (proposed by drwells; merged)
#10235: Prevent instantiation of BoundingBox<0>. (proposed by drwells; merged)
#10232: Updated doi. (proposed by luca-heltai; merged)
#10231: [9.2] Take over #10230 (proposed by tamiko; merged)
#10230: Test boost/extract_rep*_02: adjust test output for libc++ (proposed by tamiko; merged)
#10229: [9.2] Take over #10227 (proposed by tamiko; merged)
#10228: Fix warning in step70 (proposed by peterrum; merged)
#10227: Fix warning in step-70 (proposed by kronbichler; merged)
#10226: [9.2] Take over #10225 (proposed by tamiko; merged)
#10225: Fix test output forgotten in #9969 (proposed by kronbichler; merged)
#10224: [9.2] Take over #10220 (proposed by tamiko; merged)
#10223: [9.2] Take over #9078 (proposed by tamiko; merged)
#10220: tests: add additional output file for intel (proposed by tjhei; merged)
#10219: Fix assert that wrongly triggered (proposed by gassmoeller)
#10218: [9.2.] Take over #10174 (proposed by tamiko; merged)
#10217: [9.2] Take over #10198 (proposed by tamiko; merged)
#10216: [9.2] Take over #10215: Bugfix: Cells may not receive any variable size data. (proposed by marcfehling; merged)
#10215: Bugfix: Cells may not receive any variable size data. (proposed by marcfehling; merged)
#10213: [9.2] Take over #10207 (proposed by tamiko; merged)
#10212: [9.2] Take over #10208: Fix python FunctionManifold (proposed by masterleinad; merged)
#10210: [9.2] Take over #9969: Revisited binary search for parallel::distributed::GridRefinement. (proposed by marcfehling; merged)
#10209: [9.2] Take over #10013: Introduced p::d::ErrorPredictor. (proposed by masterleinad; merged)
#10208: Fix python FunctionManifold (proposed by agrayver; merged)
#10207: Fix extract_rtree_level for small problem sizes (proposed by peterrum; merged)
#10204: [9.2] Take over #10202 #10202 Update an entry in the changelog. See #10072 (proposed by tamiko; merged)
#10203: [9.2.] Take over #10201 (proposed by tamiko; merged)
#10202: Update an entry in the changelog. (proposed by bangerth; merged)
#10201: CMake: relax arpack and parpack library directory requirements (proposed by tamiko; merged)
#10200: [9.2] Take over #10199: Choose output files for mpi/condense_01 correctly (proposed by masterleinad; merged)
#10199: Choose output files for mpi/condense_01 correctly (proposed by masterleinad; merged)
#10198: Updates to step-50 (proposed by bangerth; merged)
#10196: [9.2] Take over #10195 (proposed by tamiko; merged)
#10195: Doxygen: Fix include strip (proposed by tamiko; merged)
#10194: Avoid using std::cout in a test. (proposed by drwells; merged)
#10193: [9.2] Take over #10190: Run Travis on all branches (proposed by masterleinad; merged)
#10192: Take over #10189 and #10191 (proposed by tamiko; merged)
#10191: Documentation: fix make_gallery.pl (proposed by tamiko; merged)
#10190: Run Travis on all branches (proposed by masterleinad; merged)
#10189: Documentation: Treat code gallery projects as examples (proposed by tamiko; merged)
#10187: [9.2] Take over #10178 (proposed by tamiko; merged)
#10186: [9.2] Take over #10176 (proposed by tamiko; merged)
#10185: [9.2] Take over #10179: contrib/utilities/makeofflinedoc.sh: Also install jpg (proposed by tamiko; merged)
#10184: [9.2] Take over #10183: Fix missing closing braces. (proposed by masterleinad; merged)
#10183: Fix missing closing braces. (proposed by bangerth; merged)
#10182: clarify documentation of FEEvaluation::set_dof_values() (proposed by nfehn; merged)
#10181: Always inline FEEvaluationBase::inverse_jacobian (proposed by kronbichler; merged)
#10179: contrib/utilities/makeofflinedoc.sh: Also install jpg (proposed by tamiko; merged)
#10178: doxygen: Strip full @CMAKE_SOURCE_DIR@ and @CMAKE_BINARY_DIR@ (proposed by tamiko; merged)
#10177: [9.2] Take over #10161: Removed two variables which were not used in particles/utilities.h (proposed by masterleinad; merged)
#10176: CUDA: multiple fixes (proposed by Rombur; merged)
#10174: Fix find active cell around point. (proposed by luca-heltai; merged)
#10173: Jenkins: also test release branches (proposed by tjhei; merged)
#10172: [9.2] Take over #10171 (proposed by tamiko; merged)
#10171: update fe_series tests again to latest changes (proposed by tamiko; merged)
#10170: [9.2] remove test mpi/p4est_bug (proposed by tamiko; merged)
#10169: [9.2.] Take over #10168 (proposed by tamiko; merged)
#10168: do not print mesh in opencascade/stl_* tests (proposed by tamiko; merged)
#10167: [9.2] Take over #10166 (proposed by tamiko; merged)
#10166: examples/step-69: fix texttt formulas (proposed by tamiko; merged)
#10165: let tests/mpi/p4est_bug_01 only run in debug mode (proposed by tjhei; merged)
#10164: [9.2] let tests/mpi/p4est_bug_01 only run in debug mode (proposed by tjhei)
#10163: added support for quad9 and hex27 elements (proposed by DanielPaukner)
#10162: Refactor some SD tests (proposed by jppelteret)
#10161: Removed two variables which were not used in particles/utilities.h (proposed by blaisb; merged)
#10159: [9.2] Take over #10173: Jenkins: also test release branches (proposed by tjhei; merged)
#10158: Release step 6a: Require the current version of deal.II (proposed by tamiko; merged)
#10157: Release step 5: update VERSION (proposed by tamiko; merged)
#10156: Release step 1a: Update tag list (proposed by tamiko; merged)
#10155: Instantiate OpenCASCADE (proposed by masterleinad; merged)
#10154: Release step 1: Update changelog file (proposed by tamiko; merged)
#10152: Updated doc for hp::Refinement::predict_error(). (proposed by marcfehling; merged)
#10151: Test mpi/hp_step-4 disable test for 64bit indices (proposed by tamiko; merged)
#10150: Test petsc/reinit_preconditioner_0?: disable for 64bit indices (proposed by tamiko; merged)
#10149: Fix compilation with gcc-4.9.4 (proposed by tamiko; merged)
#10148: github actions: split windows build (proposed by tjhei; merged)
#10147: doxygen: disable stuff in grid_generator.cc (proposed by tjhei; merged)
#10145: Test boost/extract_representative_set_02: add output variant, rename test (proposed by tamiko; merged)
#10144: step-50: Possible extensions (proposed by tjhei; merged)
#10143: Tests opencascade/*: Add three output variants (proposed by tamiko; merged)
#10142: Changelog (proposed by resetius; merged)
#10141: doc: update supported version numbers of trilinos and petsc (proposed by tamiko; merged)
#10140: add a mailmap entry (proposed by tamiko; merged)
#10139: Simplify internal::DoFHandlerImplementation::Policy::ParallelDistributed::distribute_dofs_on_level() (proposed by peterrum; merged)
#10138: Remove some commented code. (proposed by drwells; merged)
#10136: Fix some small things in step-44's introduction. (proposed by drwells; merged)
#10135: Remove some "dealii::"s from code examples. (proposed by drwells; merged)
#10134: Make new GridGenerator images appear in the online documentation (proposed by kronbichler; merged)
#10133: Test lac/gmres_reorthogonalize_04: Only output iteration count (proposed by tamiko; merged)
#10132: Test vector_tools/integrate_difference_04_hp_02: Make test less expensive (proposed by tamiko; merged)
#10131: Tests: grid/refine_boundary_domain - avoid roundoff errros (proposed by tamiko; merged)
#10130: Tests: avoid a race condition in grid/build_global_description_tree (proposed by tamiko; merged)
#10129: Test adolc/helper_scalar_coupled_3_components_01* - fix race condition (proposed by tamiko; merged)
#10128: Test adolc/helper_scalar_coupled_3_components_01* - fix race condition (proposed by tamiko; merged)
#10127: python_bindings: Also update order of compute_aspect_ratio (proposed by tamiko; merged)
#10126: cmake: restrict p4est tests (proposed by tamiko; merged)
#10125: Fix dimkronbichler; merged)
#10124: Reverse order of mapping and triangulation in compute_aspect_ratio (proposed by kronbichler; merged)
#10123: fix no-return warning in step-67 (proposed by tjhei; merged)
#10122: fix warning about braces (proposed by tjhei; merged)
#10121: add missing instantiations for make_boundary_sparsity_pattern (proposed by tjhei; merged)
#10118: update copyright years (proposed by tjhei; merged)
#10117: step-50: fix references (proposed by tjhei; merged)
#10116: step-50: set kind to techniques (proposed by tjhei; merged)
#10113: p:f:t: Test repeated local refinement of base triangulation (proposed by peterrum; merged)
#10112: Add author in changelog (proposed by peterrum; merged)
#10111: Make clang-tidy happy with parallel::apply_to_subranges (proposed by kronbichler; merged)
#10110: Fix ICC compilation (proposed by peterrum; merged)
#10108: Add mapping argument to find_closest_vertex_of_cell(). (proposed by luca-heltai; merged)
#10107: Run cppcheck (proposed by drwells; merged)
#10106: Fix umlaut in tooltip of tutorial graph (proposed by tjhei; merged)
#10103: Mark LaplaceOperator::apply_add as override (proposed by kronbichler; merged)
#10102: Qualify a call to parallel::apply_to_subrange (proposed by kronbichler; merged)
#10101: Doc added for constexpr support (proposed by rezarastak; merged)
#10100: Properly initalization of velocity vector (proposed by resetius; merged)
#10099: Fix compilation with gcc-10 (proposed by kronbichler; merged)
#10098: fix copyright update script updating itself (proposed by tjhei; merged)
#10097: update copyright years (proposed by tjhei; merged)
#10096: add some empty lines (proposed by tjhei; merged)
#10095: add missing override (proposed by tjhei; merged)
#10094: release step 0c: doxygen formatting (proposed by tjhei; merged)
#10093: Fix if-statements with check_for_distorted_cells. (proposed by dougshidong)
#10092: Fix sorting of cells in p:f:t (proposed by peterrum; merged)
#10091: hide boost deprecation warning with 1.73 (proposed by tjhei; merged)
#10089: remove boost include to fix compilation (proposed by tjhei; merged)
#10087: Disable hold_all_faces_to_owned_cells for FE_Q (proposed by peterrum; merged)
#10084: Fix matrix-free pre/post loops with threads (proposed by kronbichler; merged)
#10083: Make a few tests check what they are supposed to (proposed by kronbichler; merged)
#10081: merge_triangulations(): reformulate documentation (proposed by nfehn; merged)
#10080: Undo accidental change in test result file with LAPACK (proposed by kronbichler; merged)
#10079: correct docu of GridTools::transform() and GridGenerator::cylinder() (proposed by nfehn; merged)
#10078: Fix a grammar error. (proposed by bangerth; merged)
#10077: Minor update to the section on uploading test results. (proposed by bangerth; merged)
#10076: contrib/utilities/query_testsuite: modernize (proposed by tamiko; merged)
#10075: Run codespell. (proposed by drwells; merged)
#10074: Remove double word typos. (proposed by drwells; merged)
#10071: adolc/helper_tape_index_01: Increase tolerance (proposed by tamiko; merged)
#10070: arpack/step-36_ar_shift: use solver_within_range macro (proposed by tamiko; merged)
#10069: base/utilities_pack_unpack_07: Add a variant for clang-10/libc++ (proposed by tamiko; merged)
#10068: symengine/batch_optimizer: Add output variants (proposed by tamiko; merged)
#10067: symengine/batch_optimizer: Increase number of printed digits (proposed by tamiko; merged)
#10066: Disable a fallback option in the BatchOptimizer (proposed by jppelteret; merged)
#10065: Silence gcc-10 warnings about invalid array accesses (proposed by masterleinad; merged)
#10064: Tests: symengine/cse*: Disable unstable output (proposed by tamiko; merged)
#10063: Improve documentation of a BatchOptimizer function (proposed by jppelteret; merged)
#10062: Fix bug in FEFaceEvaluation::read_dof_values_plain (proposed by kronbichler; merged)
#10061: Parallel direct solver block (proposed by mwichro)
#10060: interpolate component of field to a component of another field (proposed by mwichro)
#10059: Add a changelog entry. (proposed by bangerth; merged)
#10056: Convert steps 3,4,5,6,8 and 44 to use FEValues range based loops (proposed by jppelteret; merged)
#10055: rol/vector_adaptor_02: port to Trilinos 12.18.1 (proposed by tamiko; merged)
#10054: serialization/fe_series_0?: Add test variants for libc++ (proposed by tamiko; merged)
#10053: CUDA matrix-free: overlap communication and computation (proposed by Rombur; merged)
#10052: mpi/petsc_step-27*: add a test variant for petsc-3.13 and newer (proposed by tamiko; merged)
#10051: fe/memory_consumption_01: remove test (proposed by tamiko; merged)
#10050: Some tests depend on lapack (proposed by rezarastak; merged)
#10049: clarify documentation of print_parameters() (proposed by nfehn; merged)
#10048: base/utilities_pack_unpack_07: make test more robust (proposed by tamiko; merged)
#10047: Better document C++11/14/17/20. (proposed by bangerth; merged)
#10046: Augment the documentation of operator<< for Vector. (proposed by bangerth; merged)
#10045: add missing override in MatrixFree LaplaceOperator (proposed by tjhei; merged)
#10044: DiscreteTime is preferred over TimestepControl (proposed by rezarastak; merged)
#10042: Improve the formatting of a formula in a .h file. (proposed by bangerth; merged)
#10041: Move a reference to references.bib. (proposed by bangerth; merged)
#10040: Fix some more doxygen issues. (proposed by drwells; merged)
#10039: Incompatible: Fix operator<< with Vector (proposed by bangerth; merged)
#10038: Remove some non-ascii characters. (proposed by drwells; merged)
#10036: Allow hp::DoFHandler with parallel::DistributedTriangulationBase (proposed by starki0815; merged)
#10035: Use transfinite interpolation for codim 1 refinement (proposed by starki0815; merged)
#10034: Add codim 1 instantiations of make_hanging_node_constraints() (proposed by starki0815; merged)
#10033: The tolerance parameter is removed from project_tensor (proposed by rezarastak; merged)
#10032: Suppress more TBB warnings (proposed by masterleinad; merged)
#10031: Small formatting error (proposed by tcclevenger; merged)
#10030: Add a reference to the code gallery. (proposed by bangerth; merged)
#10029: Fix C++20 warnings and errors (proposed by masterleinad; merged)
#10028: Add batch optimiser for symbolic expressions (proposed by jppelteret; merged)
#10027: Use lapack gesvd() for orthogonal_project (proposed by rezarastak)
#10026: Avoid using fabs for std::complex (proposed by masterleinad; merged)
#10025: Implement cell-wise coefficient in MF::LaplaceOperator (proposed by kronbichler; merged)
#10024: Fix some clang-10 warnings (proposed by masterleinad; merged)
#10022: Test: adjust iteration count in ginkgo test (proposed by tamiko; merged)
#10021: New extract_rtree_level function, and RTree visitor. (proposed by luca-heltai; merged)
#10020: Remove an unnecessary include file. (proposed by bangerth; merged)
#10019: Fix a test by using the stream output precision. (proposed by bangerth; merged)
#10018: Introduce std_cxx20::ranges::iota_view (proposed by bangerth; merged)
#10015: Suppress warning that tbb/task.h is deprecated (proposed by masterleinad; merged)
#10014: [step-67] Fix a wrong number in program output (proposed by kronbichler; merged)
#10013: Introduced p::d::ErrorPredictor. (proposed by marcfehling; merged)
#10012: Group cells by parents in matrix-free setup (proposed by kronbichler; merged)
#10011: Fix step-40 test: Output n_dofs rather than IndexSet (proposed by kronbichler; merged)
#10010: Test for project_onto_orthogonal_tensors improved (proposed by rezarastak; merged)
#10007: Remove some unneeded backslashes. (proposed by drwells; merged)
#10005: Comment on the use of thread-safe BLAS/LAPACK (proposed by kronbichler; merged)
#10004: Better document missing refinement edge data in MF for DG (proposed by kronbichler; merged)
#10003: Split up matrix-free compilation into more files (proposed by kronbichler; merged)
#10002: Convert some loops over cells to range-based for loops (proposed by kronbichler; merged)
#10001: Remove quartic complexity from create_coupling_mass_matrix (proposed by kronbichler; merged)
#9999: Convert steps 4,5,6 to FEValues::quadrature_point_indices(). (proposed by bangerth; merged)
#9998: Minor updates to the DiscreteTime class documentation. (proposed by bangerth; merged)
#9997: Remove MeshWorker::CopyData::operator=(double) (proposed by jppelteret; merged)
#9996: CMake: Clear all cached variables in FindGINKGO.cmake (proposed by tamiko; merged)
#9994: Integrate std::simd (proposed by peterrum)
#9993: Fix SFINAE detection of LinOp for matrix-free operators (proposed by kronbichler; merged)
#9992: speed up tests/non_matching/coupling_08 (proposed by tjhei; merged)
#9991: Add Utilities::MPI::create_evenly_distributed_partitioning() (proposed by dougshidong; merged)
#9990: Add ranged based loops for local DoF indices to FEValuesBase (proposed by jppelteret; merged)
#9987: Add range based loop for quadrature points to FEValuesBase (proposed by jppelteret; merged)
#9986: Fix copying hp::FEValues objects. (proposed by bangerth; merged)
#9985: Remove two unused headers. (proposed by drwells; merged)
#9984: CI: clang-tidy all headers (proposed by tjhei; merged)
#9983: rename header guards in noncontiguous_partitioner (proposed by tjhei; merged)
#9982: tidy warning: deprecated errno.h header (proposed by tjhei)
#9981: qualify internal namespace with dealii:: (proposed by tjhei; merged)
#9980: Improve error message in SymmetricTensor constructor. (proposed by simonsticko; merged)
#9979: Implement hessian and laplacian on ConstantFunction. (proposed by simonsticko; merged)
#9978: Fix FEInterface for MG support (proposed by mwichro; merged)
#9977: Duplicate include statements removed (proposed by rezarastak; merged)
#9976: Fix more funny spacings (proposed by masterleinad; merged)
#9975: Fix a funny spacing issue. (proposed by bangerth; merged)
#9974: Restrict mpi/petsc_step-27 (proposed by masterleinad; merged)
#9973: make ARKode ODE solver use DiscreteTime internally (proposed by rezarastak)
#9970: remove empty virtual destructors (proposed by tjhei; merged)
#9969: Revisited binary search for parallel::distributed::GridRefinement. (proposed by marcfehling; merged)
#9968: Precalculate hp::FEValues. (proposed by marcfehling; merged)
#9967: improve docu of DataOut::add_data_vector() (proposed by nfehn; merged)
#9966: Fix two formulas in step-58. (proposed by bangerth; merged)
#9964: Fix assertion in CUDA (proposed by Rombur; merged)
#9963: replace a std::bind by lambda (proposed by tjhei; merged)
#9962: Simplify parallel::TriangulationBase::update_number_cache (proposed by peterrum; merged)
#9960: Fix calling TrilinosWrappers::BlockSparseMatrix::reinit with BlockSparseMatrix (proposed by masterleinad; merged)
#9959: Fix doxygen appearance copy_new_triangulation_to_p4est (proposed by peterrum; merged)
#9958: Remove 1D hack from p:d:t (proposed by peterrum; merged)
#9956: Add documentation for hidden serialize() functions (proposed by jppelteret; merged)
#9955: Remove the last deprecations (proposed by masterleinad; merged)
#9954: Reworked error prediction algorithm. (proposed by marcfehling; merged)
#9953: Include ComponentMask in vector_tools_interpolate.h (proposed by kronbichler; merged)
#9952: Remove domain_partitioner and range_partitioner from TrilinosWrappers (proposed by masterleinad; merged)
#9951: Allow LinOp(TrilinosMatrix). (proposed by dougshidong; merged)
#9950: Add ParameterHandler::print_parameters with std::string as input. (proposed by luca-heltai; merged)
#9949: Make parallel::shared::Triangulation::update_number_cache private (proposed by peterrum; merged)
#9948: Make coarse_cell_*_to_coarse_cell_* private (proposed by peterrum; merged)
#9946: Fix a few tests (proposed by kronbichler; merged)
#9945: Remove parallel::TriangulationBase::compute_n_locally_owned_active_cellls_per_processor (proposed by peterrum; merged)
#9944: Create GridTools::compute_vertices_with_ghost_neighbors() (proposed by peterrum; merged)
#9943: Remove deprecated TrilinosWrappers constructors and reinitializations (proposed by masterleinad; merged)
#9941: Add changelog entry for "Add Tvmult to Petsc PreconditionJacobi" (proposed by dangars; merged)
#9940: Fix a typo. (proposed by bangerth; merged)
#9938: const is removed from private member variables of DiscreteTime (proposed by rezarastak; merged)
#9937: Remove PETScWrappers deprecations (proposed by masterleinad)
#9936: Improve calculating boolean values (proposed by rezarastak; merged)
#9935: Remove some pthread vestiges that were deprecated a while ago already (proposed by bangerth; merged)
#9934: Explicitly =delete copy operators for TaskDescriptor. (proposed by bangerth; merged)
#9930: CI: update clang-tidy to clang10 (proposed by tjhei; merged)
#9929: Split VectorTools up (proposed by masterleinad; merged)
#9925: Instantiate AffineConstraints::distribute_local_to_global (proposed by peterrum; merged)
#9920: Remove doc/doxygen/tutorial (proposed by masterleinad; merged)
#9919: Extend OutputStyle (proposed by peterrum; merged)
#9898: Remove debug output in step-52. (proposed by bangerth; merged)
#9892: Step 58: The nonlinear Schroedinger equation (proposed by bangerth; merged)
#9891: Interpolate field on particles (proposed by blaisb; merged)
#9883: Finish step-50 (proposed by tcclevenger; merged)
#9868: Add documentation on using CCache (proposed by jppelteret; merged)
#9847: Rename NoncontiguousPartitioner::update_values() (proposed by peterrum; merged)
#9835: Parallelize the main loops of MappingInfo::compute_mapping_q (proposed by kronbichler; merged)
#9807: Add additional cell options for 3D hyper shell (proposed by kronbichler; merged)
#9802: Add alternative GridGenerator::hyper_ball with better balance of cells (proposed by kronbichler; merged)
#9748: Improve DiscreteTime and use it in step 21 (proposed by rezarastak; merged)
#9558: step-47: Add derivation for the simply supported plates to result section. (proposed by sophy1029; merged)
#9391: Refactor settings of p:f:t (proposed by peterrum; merged)
#9264: added measure computation for distorted 2d cells (proposed by nicola-giuliani; merged)
#9078: Step 70 (proposed by luca-heltai; merged)
#9076: Particle interpolation sparsity matrix (proposed by luca-heltai; merged)
#8711: [Post 9.2] Remove PolynomialType template argument from FE_Poly (proposed by GrahamBenHarper; merged)
#8603: add failing p4est test (proposed by tjhei; merged)
#7513: Introduced SmoothnessEstimator. (proposed by marcfehling; merged)

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

#10414 Multithreaded direct solvers (opened)
#10401 Implement FEEvaluation::submit_hessian() (opened)
#10400 clang-10 PETSc/Trilinos warnings (opened)
#10391 Thread cleanup (opened)
#10388 TaskFlow: How to start a single task (opened)
#10381 Code gallery isn't linked into the documentation any more (opened)
#10370 Allow changing the quadrature for a FEValuesBase object? (opened)
#10366 Better visibility for the AD feature from recent versions of deal.ii (beginning from 9.1) (opened)
#10365 Remove the redundant edge (40->67) in the tutorial dependency graph (opened and closed)
#10358 step-69: Need videos on youtube (opened and closed)
#10351 particles/particle_handler_06 fails with an error (opened)
#10350 Particles: Need a way to get notified when a particle is lost (opened and closed)
#10349 Fix compilation with -std=c++20 and gcc-10 (opened)
#10340 Ensure ABI stability with C++17/20 feature selection (opened and closed)
#10339 Update documentation for C++14 (opened)
#10333 Merge DoFHandler and hp::DoFHandler - follow up tasks (opened)
#10331 Configuration, make setup_tests etc. succeed even if MPIEXEC_EXECUTABLE is not found (opened)
#10330 dyld: malformed mach-o: load commands size (33848) > 32768 (opened)
#10321 Remove `Threads::Thread` and associated `Threads::new_thread` (opened and closed)
#10314 Add a function to get a DoFHandler iterator from a particle (opened)
#10311 Replace the TBB pipeline with C++14 or TaskFlow features (opened)
#10310 Deprecate all implicit mappings? (opened)
#10304 VisIt does not support VTKFlags::write_higher_order_cells (opened and closed)
#10296 switch to c++ 14 (opened and closed)
#10295 code gallery: broken internal hyperlinks (opened)
#10284 Bug in AffineConstraintsData (opened)
#10281 step-70: Create output directory if necessary (opened)
#10273 step-70: included prms are broken (opened and closed)
#10270 step-70: PETSc version is broken (opened and closed)
#10263 ParticleHandler documentation issue (opened)
#10262 step-70: Misnamed variables (opened and closed)
#10255 improve docu of MatrixFree::get_cell_iterator() (opened)
#10246 complex number product type deduction is wrong (opened and closed)
#10243 step-70: Missing viz file (opened and closed)
#10240 Issues with copyright script. (opened and closed)
#10239 void cast in Assert (opened and closed)
#10234 step-70: Reclassify as a "fluids" kind of tutorial (opened and closed)
#10233 step-70: Can't use formulas in tutorial section headings (opened and closed)
#10222 intel constexpr failure (opened)
#10221 boundingbox_6 and dim==0 errors (opened and closed)
#10214 Multiple valid CUDAWrappers::MatrixFree objects is not allowed (opened)
#10211 Bug in ParticleHandler. (opened and closed)
#10206 Introduce cell->child_iterators() (opened)
#10205 Rename TriaAccessor::number_of_children (opened)
#10197 Building with MPI requires arpack even though parpack is found (opened and closed)
#10188 step-50 question: what is n_p? (opened and closed)
#10180 Release 9.2.0: unable to generate non-mathjax offline doc (opened and closed)
#10175 Bug on find_active_cell_around_point for p::d::t. (opened)
#10160 Segfault in tests/manifold_wrapper.py (opened and closed)
#10153 Create MatrixFree::recategorize() (opened)
#10146 Compilation failure with gcc-4.9.4 (opened and closed)
#10137 dealii.org Certificate Expired (opened and closed)
#10120 Compiler warning in matrix free task_info.cc (opened and closed)
#10119 linker errors with Intel compiler (opened and closed)
#10115 New feature: VectorNorm for fixed_fraction refinement. (opened)
#10114 [step-50] Missing references in introduction (opened and closed)
#10109 Order of arguments in GridTools::compute_aspect_ratio_of_cells (opened and closed)
#10105 Compilation issue in mapping_info.templates.h (version 9.2.0-pre) (opened and closed)
#10104 Modules for pre- and post-processing (opened)
#10090 boost placeholder warning with 1.73 (opened and closed)
#10088 boost 1.73 compile issues (opened and closed)
#10086 opencascade/stl_* failing (opened and closed)
#10085 p::f::t crash with a multi-level mesh (opened and closed)
#10082 Revisit and simplify SymEngine test output (opened)
#10073 deal.II Release 9.2.0 - Testsuite status (opened and closed)
#10072 deal.II Release 9.2.0 (released 2020/05/20) (opened)
#10058 Convert FEValuesBase::dof_indices_*() to std_cxx20::ranges::iota_view (opened and closed)
#10057 Introduce a function indicating the compiler that a number is a power of 2 (opened)
#10043 Tutorial introducing particles (step-68?) (opened)
#10037 Coupling bulk and surface processes (opened)
#10023 Error when Using deal.II on native Windows (opened and closed)
#10017 operator << (std::ostream&, const Vector &) does not respect stream settings (opened and closed)
#10016 Compatibility with current symengine dev version (opened)
#10009 Some improvements for project_onto_orthogonal_tensors (opened)
#10008 Compilation failure with current development version of ginkgo (opened)
#10006 Instantiate all OpenCASCADE classes also for dim=2, spacedim=2 (opened and closed)
#10000 Create alias for std::ranges::views::iota_view (opened and closed)
#9995 Possible memory leak with Zoltan package in release mode (opened)
#9989 create_coupling_mass_matrix too slow (opened and closed)
#9988 Add ranged based loops for local DoF indices to FEValuesBase (opened and closed)
#9972 Add quadrature_point_indices() to FeValuesBase (opened and closed)
#9971 Mesh loop assemble_boundary_faces uses empty data structures (opened and closed)
#9965 Improve docu of DataOut::add_data_vector() (opened and closed)
#9961 Reinitialize vector with any matrix's domain/range (opened)
#9957 Implicit conversion warning in trilinos_block_sparse_matrix (opened and closed)
#9947 Doxygen: copy_new_triangulation_to_p4est (opened and closed)
#9942 Doxygen creates pages for built-in types (opened)
#9939 "libpthreads"? (opened and closed)
#9933 CI: let clang-tidy also parse all headers (closed)
#9928 CI: update clang-tidy version (closed)
#9923 Generate documentation where is BOOST_SERIALIZATION_SPLIT_MEMBER used (closed)
#9914 Doxygen shows template specializations (closed)
#9903 Check the usage of OutputStyle::XML and ::JSON in ParameterHandler (closed)
#9889 ParameterAcceptor::initialize broken (closed)
#9888 Configuration of I/O of ParameterHandler (closed)
#9729 deal.II Release 9.2.0 - Open pull requests (closed)
#9689 Group cells for data locality in matrix-free setup (closed)
#9621 building deal.ii with ninja (closed)
#9597 Extend error prediction algorithm for hp refinement. (closed)
#9538 Copy the graph of modules from the new deal.II paper to the documentation (closed)
#9426 Dealing with clamped boundary conditions in step-47 (closed)
#9405 Post-function in matrix-free cell_loop() is not executed correctly when not using AdditionalData::none (closed)
#9316 Specifying MPI libraries (closed)
#9212 Update TBB to use its latest CMake-based build system (closed)
#9135 Conflict in LAPACK function prototypes (closed)
#9068 Reserve step-70 (closed)
#9009 FullMatrix::gauss_jordan() returns incorrect inverse in multithreading. (closed)
#8920 Documentation of GridGenerator::cylinder() incomplete and incorrect. (closed)
#8735 doxygen: avoid Python dependency for setting canonical links (closed)
#8544 Does the build system depend on python? (closed)
#8482 step-50 TODO list (closed)
#8460 Access functionality for MatrixFree on faces (closed)
#8198 GridGenerator::hyper_ball: Do we want alternative variant? (closed)
#7922 GridTools::find_closest_vertex_of_cell ignores mapping (closed)
#7183 Wrapper for the ginkgo numerical linear algebra library. (closed)
#5938 clang-tidy (closed)
#5746 step-58: Solving the Nonlinear Schroedinger Equation with an operator splitting approach (closed)
#5627 VectorView is deprecated but ArrayView does not provide the same functionality (closed)
#4608 [Post-9.0] Revisit TableIndices constructors (closed)
#3774 Rename the compute_n_pols() functions for polynomial spaces (closed)
#2914 Python binding (closed)
#2795 Improve continuous integration (closed)
#1973 FEValues cleanup: Remove polynomial space template argument from FE_Poly and FE_PolyTensor (closed)
#1681 get appveyor for windows build testing to work (closed)
#711 Better ways to filter which cells to consider in DataOut (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