Hello everyone!

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

#5361: Fix warnings regarding extra';' and unused parameters (proposed by 
masterleinad) https://github.com/dealii/dealii/pull/5361

#5360: Fix using inhomogeneous boundary conditions in VectorTools::project 
(proposed by masterleinad) https://github.com/dealii/dealii/pull/5360

#5358: New function parallel::GridTools::exchange_local_bounding_boxes 
(proposed by GivAlz) https://github.com/dealii/dealii/pull/5358

#5357: Document how to treat inhomogeneous Dirichlet values with MatrixFree 
(proposed by kronbichler) https://github.com/dealii/dealii/pull/5357

#5356: Replace static const by static constexpr in FEEValuation (proposed by 
masterleinad; merged) https://github.com/dealii/dealii/pull/5356

#5355: Fix Patterns::Tuple::description (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/5355

#5353: fix boost zlib detection configure check (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/5353

#5352: Deprecate BlockTrianglePrecondition and BlockMatrixArray. (proposed by 
drwells; merged) https://github.com/dealii/dealii/pull/5352

#5350: Remove references to an old function. (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/5350

#5349: Update bundled boost to allow to compile with clang-9.0 (proposed by 
masterleinad; merged) https://github.com/dealii/dealii/pull/5349

#5348: Fix FEEvaluation::dofs_per_cell for vector-valued case (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/5348

#5347: fixes for Petsc / Slepc 3.8 (proposed by davydden; merged) 
https://github.com/dealii/dealii/pull/5347

#5345: Make some things work for complex-valued vectors. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/5345

#5344: Fix a tensor index. (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/5344

#5342: Simplify variadic constructors of Patterns::Tuple. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/5342

#5341: Fix recent test and test result (proposed by gassmoeller; merged) 
https://github.com/dealii/dealii/pull/5341

#5340: Add an assertion to provide a nicer error message. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/5340

#5338: Convert<tuple> struct. (proposed by luca-heltai; merged) 
https://github.com/dealii/dealii/pull/5338

#5335: Allow DataEntry functions to return either the real or imaginary part. 
(proposed by bangerth) https://github.com/dealii/dealii/pull/5335

#5334: Reintroduce old `VectorTools::interpolate` as fallback (proposed by 
gassmoeller; merged) https://github.com/dealii/dealii/pull/5334

#5333: Let DataOut vector wrappers report whether the data type is complex. 
(proposed by bangerth; merged) https://github.com/dealii/dealii/pull/5333

#5332: Add some Sacado::RFad and nested RFad-DFad examples to the testsuite 
(proposed by jppelteret; merged) https://github.com/dealii/dealii/pull/5332

#5331: Patterns::Tuple (proposed by luca-heltai; merged) 
https://github.com/dealii/dealii/pull/5331

#5330: Relax requirements for external BOOST for DEAL_WITH_ZLIB=OFF (proposed 
by masterleinad; merged) https://github.com/dealii/dealii/pull/5330

#5329: Remove BZIP2 dependency (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/5329

#5328: add exception messages (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/5328

#5327: Fix typo in description of CMake setup for packages (proposed by 
masterleinad; merged) https://github.com/dealii/dealii/pull/5327

#5326: Avoid numdiff check race condition in test (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/5326

#5325: Add a check when comparing iterators. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/5325

#5324: fix zlib tests (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/5324

#5323: Avoid numdiff check race condition in test (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/5323

#5322: make zlib optional (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/5322

#5321: re-declare update_number_cache() as protected (proposed by 
vishalkenchan; merged) https://github.com/dealii/dealii/pull/5321

#5319: add LAPACKFullMatrix::add() (proposed by davydden; merged) 
https://github.com/dealii/dealii/pull/5319

#5318: Fix boost iostreams (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/5318

#5316: Avoid exceptions without message. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/5316

#5315: Fix VectorTools::interpolate for parallel computations (proposed by 
gassmoeller; merged) https://github.com/dealii/dealii/pull/5315

#5314: Added new compute point locations to GridTools (proposed by GivAlz; 
merged) https://github.com/dealii/dealii/pull/5314

#5313: Fix mapping cartesian update inverse jacobian (proposed by gassmoeller; 
merged) https://github.com/dealii/dealii/pull/5313

#5312: Add some modified Sacado::Fad::DFad examples to the testsuite (proposed 
by jppelteret; merged) https://github.com/dealii/dealii/pull/5312

#5311: Replace use of VectorView in library (proposed by kronbichler; merged) 
https://github.com/dealii/dealii/pull/5311

#5310: typo in qtelles (proposed by nicola-giuliani; merged) 
https://github.com/dealii/dealii/pull/5310

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

#5308: Change argument of DoFRenumbering::downstream() to Tensor<1,dim>. 
(proposed by bangerth; merged) https://github.com/dealii/dealii/pull/5308

#5307: Add missing include in cuda_vector.h (proposed by Rombur; merged) 
https://github.com/dealii/dealii/pull/5307

#5306: Clean up code in 
MGLevelGlobalTransfer::fill_and_communicate_copy_indices. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/5306

#5305: add note on how to install qtcreator style files (proposed by tjhei; 
merged) https://github.com/dealii/dealii/pull/5305

#5304: Make Vector::values a std::unique_ptr. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/5304

#5303: Make sure to actually zero the ghost entries in partitioner import call. 
(proposed by kronbichler; merged) https://github.com/dealii/dealii/pull/5303

#5302: Add test for Functions::FEFieldFunction::compute_point_locations 
(proposed by GivAlz; merged) https://github.com/dealii/dealii/pull/5302

#5301: change static_assert into Assert for CylindricalManifold to make it e... 
(proposed by davydden; merged) https://github.com/dealii/dealii/pull/5301

#5300: Fix unused variables, functions and parameters (with clang) (proposed by 
masterleinad; merged) https://github.com/dealii/dealii/pull/5300

#5299: fix wrong operator in mapping_q_eulerian_09 (proposed by davydden; 
merged) https://github.com/dealii/dealii/pull/5299

#5297: Prefer using nullptr over 0 or NULL (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/5297

#5296: Prefer using emplace_back (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/5296

#5295: Use bool literals instead of integer values (proposed by masterleinad; 
merged) https://github.com/dealii/dealii/pull/5295

#5294: Mark more variables const (reference) (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/5294

#5293: Take hp objects by const (reference) access (proposed by masterleinad; 
merged) https://github.com/dealii/dealii/pull/5293

#5292: Take IndexSet by const& (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/5292

#5291: Move VectorOperation into its own header. (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/5291

#5290: Smaller fixes for ParameterAcceptor (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/5290

#5288: Remove unnecessary #include statements. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/5288

#5287: Update a formula. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/5287

#5286: pass std::function by const reference (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/5286

#5285: Documentation fixes for the Physics::Notation::Kelvin namespace. 
(proposed by jppelteret; merged) https://github.com/dealii/dealii/pull/5285

#5284: SmartPointer: use nullptr instead of 0 (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/5284

#5283: remove hp::DoFHandler::ExcInvalidTriangulation (proposed by tjhei; 
merged) https://github.com/dealii/dealii/pull/5283

#5282: Rename Vector::val to Vector::values. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/5282

#5281: assert having Triangulation in DoFHandler (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/5281

#5280: document FE::doc_component_to_base_table (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/5280

#5279: small documentation fixes (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/5279

#5277: Implement parallel DoF renumbering on multigrid levels (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/5277

#5275: Update some discussion in DataOutFilter. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/5275

#5274: Update some discussion in step-9. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/5274

#5273: Use std::unique_ptr for parallel::Vector::val (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/5273

#5272: Initialize all variables in Partitioner (proposed by masterleinad; 
merged) https://github.com/dealii/dealii/pull/5272

#5271: Add CUDA quick test (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/5271

#5270: Avoid std::abs() on unsigned types. (proposed by kronbichler; merged) 
https://github.com/dealii/dealii/pull/5270

#5268: Use unique_ptr instead of raw pointers in distributed::Vector. (proposed 
by bangerth; merged) https://github.com/dealii/dealii/pull/5268

#5267: extend example of user projects testsuite to contain header files 
(proposed by davydden; merged) https://github.com/dealii/dealii/pull/5267

#5266: add a boolean flag to MatrixFreeOperators::Base::compute_diagonal() t... 
(proposed by davydden; merged) https://github.com/dealii/dealii/pull/5266

#5261: Restructure DataOutFilter (proposed by gassmoeller; merged) 
https://github.com/dealii/dealii/pull/5261

#5250: Add Kelvin notation to the physics module. (proposed by jppelteret; 
merged) https://github.com/dealii/dealii/pull/5250

#5248: Make sure to not call memset with a nullptr (proposed by masterleinad; 
merged) https://github.com/dealii/dealii/pull/5248

#5240: Particle serialization fixes (proposed by gassmoeller; merged) 
https://github.com/dealii/dealii/pull/5240

#5239: update testsuite documentation (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/5239

#5233: Rename the scalar template type of Function and derived classes. 
(proposed by bangerth; merged) https://github.com/dealii/dealii/pull/5233

#5225: Remove unused methods (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/5225

#5205: add FiniteElement::get_sub_fe (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/5205

#5150: Add distributed refinement/coarsening/serialization signals (proposed by 
gassmoeller; merged) https://github.com/dealii/dealii/pull/5150


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

#5359: parallel::shared::Triangulation should exchange refinement flags 
(opened) https://github.com/dealii/dealii/issues/5359

#5354: failing tests matrix-free (opened and closed) 
https://github.com/dealii/dealii/issues/5354

#5351: config mistakenly thinks boost's iostreams is not compiled with zlib 
(opened and closed) https://github.com/dealii/dealii/issues/5351

#5346: CellDataStorage does not work with primitive data types (opened) 
https://github.com/dealii/dealii/issues/5346

#5343: Fix FEEvaluation::dofs_per_cell for vector-valued case (opened and 
closed) https://github.com/dealii/dealii/issues/5343

#5339: Document how to handle non-homogeneous Dirichlet constraints in step-37  
(opened) https://github.com/dealii/dealii/issues/5339

#5337: Failing test: numerics/data_out_filter_01 (opened and closed) 
https://github.com/dealii/dealii/issues/5337

#5336: Failing CUDA quick_test using CUDA-9 (opened) 
https://github.com/dealii/dealii/issues/5336

#5320: failing tests on petsc 3.8 / slepc 3.8  (opened) 
https://github.com/dealii/dealii/issues/5320

#5317: Clean up mandatory ZLIB dependendy (opened and closed) 
https://github.com/dealii/dealii/issues/5317

#5298: SphericalManifold give different results than HyperBallBoundary. Same 
with CylindricalManifold (opened) https://github.com/dealii/dealii/issues/5298

#5289: Undefined references for BOOST compiled without ZLIB und 
DEAL_II_WITH_ZLIB=ON (opened and closed) 
https://github.com/dealii/dealii/issues/5289

#5278: Deprecate VectorView (opened) 
https://github.com/dealii/dealii/issues/5278

#5276: Simplify Physics::Notation::to_tensor() (opened) 
https://github.com/dealii/dealii/issues/5276

#5269: changes to MPI partitioner broke build (opened and closed) 
https://github.com/dealii/dealii/issues/5269

#5185: shallow copy / view for some blocks in a BlockVector (interface to 
Anasazi eigensolvers) (closed) https://github.com/dealii/dealii/issues/5185

#5155: add FiniteElement::extract(ComponentMask) (closed) 
https://github.com/dealii/dealii/issues/5155

#4643: Remove references to compute_support_points (closed) 
https://github.com/dealii/dealii/issues/4643

#3733: Fix the interface of new_pointer_matrix_base (closed) 
https://github.com/dealii/dealii/issues/3733

#1886: Bug in GridGenerator::half_hyper_shell ? (closed) 
https://github.com/dealii/dealii/issues/1886


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.

Reply via email to