Hello everyone! This is deal.II newsletter #6. 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: #5164: Two small cleanups in the code that computes hanging node constraints. (proposed by bangerth) https://github.com/dealii/dealii/pull/5164 #5163: Remove unused parameter (proposed by masterleinad; merged) https://github.com/dealii/dealii/pull/5163 #5162: Restrict tests requiring p4est (proposed by masterleinad; merged) https://github.com/dealii/dealii/pull/5162 #5161: Add DEAL_II_PETSC_WITH_HYPRE. (proposed by drwells; merged) https://github.com/dealii/dealii/pull/5161 #5160: bounding box for triangulation and cell iterators [WIP] (proposed by danshapero) https://github.com/dealii/dealii/pull/5160 #5159: Update documentation in VectorMemory and derived classes. (proposed by bangerth; merged) https://github.com/dealii/dealii/pull/5159 #5158: Avoid raw pointers in favor of VectorMemory::Pointer in SolverQMRS. (proposed by bangerth; merged) https://github.com/dealii/dealii/pull/5158 #5157: minor: step-56: consistent template arg naming (proposed by tjhei; merged) https://github.com/dealii/dealii/pull/5157 #5156: ARKode interface. (proposed by luca-heltai; merged) https://github.com/dealii/dealii/pull/5156 #5154: extend LAPACKFullMatrix to do Cholesky, inverse of SPD, norms and con... (proposed by davydden) https://github.com/dealii/dealii/pull/5154 #5153: Avoid raw pointers in SUNDIALS IDA interfaces. (proposed by bangerth; merged) https://github.com/dealii/dealii/pull/5153 #5152: Better document MPILogInitAll. (proposed by bangerth; merged) https://github.com/dealii/dealii/pull/5152 #5151: Improve VectorTools::interpolate: Transformation for systems (proposed by tamiko) https://github.com/dealii/dealii/pull/5151 #5150: Add distributed refinement/coarsening/serialization signals (proposed by gassmoeller) https://github.com/dealii/dealii/pull/5150 #5149: More steps towards hp in parallel. (proposed by bangerth; merged) https://github.com/dealii/dealii/pull/5149 #5148: Fix FindASSIMP.cmake and improve DEAL_II_DISABLE_EXTRA_DIAGNOSTICS (proposed by tamiko; merged) https://github.com/dealii/dealii/pull/5148 #5147: Restrict lac/utilities_02 to only run with LAPACK (proposed by masterleinad; merged) https://github.com/dealii/dealii/pull/5147 #5146: Restrict multigrid tests to only run with LAPACK (proposed by masterleinad; merged) https://github.com/dealii/dealii/pull/5146 #5144: Temporarily disable two tests (proposed by tamiko; merged) https://github.com/dealii/dealii/pull/5144 #5143: Move a function out of an anonymous namespace. (proposed by drwells; merged) https://github.com/dealii/dealii/pull/5143 #5142: explicitly oversubscribe with MPI (proposed by davydden; merged) https://github.com/dealii/dealii/pull/5142 #5140: Introduce ArrayView::cbegin and ArrayView::cend (proposed by masterleinad; merged) https://github.com/dealii/dealii/pull/5140 #5138: fix a bug in codim_one/error_estimator_02 test (proposed by davydden) https://github.com/dealii/dealii/pull/5138 #5137: add missing instantiations of DataOutBase::write_filtered_data (proposed by davydden; merged) https://github.com/dealii/dealii/pull/5137 #5136: add missing instantiation for ConstraintMatrix::distribute_local_to_g... (proposed by davydden; merged) https://github.com/dealii/dealii/pull/5136 #5135: fix Python wrappers warnings (proposed by davydden; merged) https://github.com/dealii/dealii/pull/5135 #5134: increase precision in Slepc SHEP test to avoid missed eigenpairs (proposed by davydden; merged) https://github.com/dealii/dealii/pull/5134 #5131: add yet another pair of outputs for Metis on macOS with Clang 9.0.0 (proposed by davydden) https://github.com/dealii/dealii/pull/5131 #5129: additional output for fe_move on macOS (proposed by davydden; merged) https://github.com/dealii/dealii/pull/5129 #5125: [WIP] Add particle handler (proposed by gassmoeller) https://github.com/dealii/dealii/pull/5125 #5124: Added functions merge_with and volume to BoundingBox (proposed by GivAlz; merged) https://github.com/dealii/dealii/pull/5124 #5122: Suppress a warning about an unused argument. (proposed by bangerth; merged) https://github.com/dealii/dealii/pull/5122 #5121: Make some function arguments 'const'. (proposed by bangerth; merged) https://github.com/dealii/dealii/pull/5121 #5119: Provide 64-bit test output variants. (proposed by bangerth) https://github.com/dealii/dealii/pull/5119 #5117: Function to compute bounding boxes of locally_owned part of a distributed triangulation (adding to distributed/grid_tools) (proposed by GivAlz) https://github.com/dealii/dealii/pull/5117 #5116: ParameterAcceptor. (proposed by luca-heltai; merged) https://github.com/dealii/dealii/pull/5116 #5115: Fix serialization of DoFHandler and Triangulation for clang-5 (proposed by masterleinad; merged) https://github.com/dealii/dealii/pull/5115 #5114: Add distribute_mg_dof functionality for a parallel::shared::Triangulation (proposed by tcclevenger) https://github.com/dealii/dealii/pull/5114 #5111: Marks some input arguments as 'const'. (proposed by bangerth; merged) https://github.com/dealii/dealii/pull/5111 #5109: facilitate transfer of fine-level solution to MG levels and test it with MappingQEulerian (proposed by davydden) https://github.com/dealii/dealii/pull/5109 #5104: Improve documentation for MultigridTransfer::copy_to_mg (proposed by masterleinad; merged) https://github.com/dealii/dealii/pull/5104 #5101: Add a test. (proposed by bangerth; merged) https://github.com/dealii/dealii/pull/5101 #5095: Assimp support and GridIn::read_assimp. (proposed by luca-heltai; merged) https://github.com/dealii/dealii/pull/5095 #5090: Be more generous in what types we allow in the FESystem(...) constructor (proposed by bangerth; merged) https://github.com/dealii/dealii/pull/5090 #5077: use range-based for and other C++11 features in tutorials (proposed by danshapero; merged) https://github.com/dealii/dealii/pull/5077 #5072: GridTools::Cache (was TriangulationInfoCache). (proposed by luca-heltai; merged) https://github.com/dealii/dealii/pull/5072 #4994: Setup and use DEAL_II_PETSC_WITH_MUMPS in PETSc solver. (proposed by jppelteret; merged) https://github.com/dealii/dealii/pull/4994 #4857: Generalized support points / interpolation (proposed by tamiko; merged) https://github.com/dealii/dealii/pull/4857 ## And this is a list of recently opened or closed discussions: #5155: add FiniteElement::extract(ComponentMask) (opened) https://github.com/dealii/dealii/issues/5155 #5145: Multiple issues with assimp cmake configure (opened and closed) https://github.com/dealii/dealii/issues/5145 #5141: slepc/step-36_parallel_02 failing (opened) https://github.com/dealii/dealii/issues/5141 #5139: sundials: compiler warnings (opened and closed) https://github.com/dealii/dealii/issues/5139 #5133: serialization/[dof_handler_01|triangulation_01|triangulation_02] fails with newest clang (opened) https://github.com/dealii/dealii/issues/5133 #5132: mpi/data_out_hdf5_02.mpirun=1 fails on macOS (opened and closed) https://github.com/dealii/dealii/issues/5132 #5130: lac/constraints_local_to_global_rect fails on macOS (opened and closed) https://github.com/dealii/dealii/issues/5130 #5128: dofs/interpolate_q_system_mixed_01.debug (opened and closed) https://github.com/dealii/dealii/issues/5128 #5127: codim_one/error_estimator_02.debug fails on macOS (opened and closed) https://github.com/dealii/dealii/issues/5127 #5126: bits/step-15.[debug|release] (opened and closed) https://github.com/dealii/dealii/issues/5126 #5123: over-subscription in MPI tests (opened and closed) https://github.com/dealii/dealii/issues/5123 #5120: Bug in tensor contract (opened) https://github.com/dealii/dealii/issues/5120 #5118: fe/fe_move* tests failing with clang (opened and closed) https://github.com/dealii/dealii/issues/5118 #5085: Serialization failures with boost-1.65.0 (closed) https://github.com/dealii/dealii/issues/5085 #5044: ARKODE interface. (closed) https://github.com/dealii/dealii/issues/5044 #4935: Improve usage of VectorMemory (closed) https://github.com/dealii/dealii/issues/4935 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. For more options, visit https://groups.google.com/d/optout.