Hello everyone!

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

#14440: Add operator==/!= also for TriaIterator and TriaActiveIterator. 
(proposed by bangerth) https://github.com/dealii/dealii/pull/14440

#14439: Fix a misspelling in a comment. (proposed by bangerth) 
https://github.com/dealii/dealii/pull/14439

#14438: Remove need to store MPI communicator in PETScWrappers::SolverBase 
(proposed by bangerth) https://github.com/dealii/dealii/pull/14438

#14437: Fix step76 document (proposed by quangx) 
https://github.com/dealii/dealii/pull/14437

#14436: Update CI workflow to CUDA 11.8 (proposed by Rombur) 
https://github.com/dealii/dealii/pull/14436

#14435: Fix flags for Trilinos+Kokkos (proposed by masterleinad) 
https://github.com/dealii/dealii/pull/14435

#14434: DoFTools: Remove template on sparsity pattern type. (proposed by 
drwells) https://github.com/dealii/dealii/pull/14434

#14433: multigrid tools: Remove template on sparsity pattern type. (proposed by 
drwells) https://github.com/dealii/dealii/pull/14433

#14432: Particles: Remove template on sparsity pattern type. (proposed by 
drwells; merged) https://github.com/dealii/dealii/pull/14432

#14431: NonMatching: Remove template on sparsity pattern type. (proposed by 
drwells; merged) https://github.com/dealii/dealii/pull/14431

#14429: Build CUDA tests in CUDA CI (proposed by masterleinad) 
https://github.com/dealii/dealii/pull/14429

#14428: Let all SolverCG constructors take MPI_Comm. (proposed by marcfehling) 
https://github.com/dealii/dealii/pull/14428

#14427: Make TrilinosWrappers::MPI::Vector::reinit accept 
Utilities::MPI::Partitioner. (proposed by marcfehling; merged) 
https://github.com/dealii/dealii/pull/14427

#14425: Guard Belos code with macros (proposed by Rombur; merged) 
https://github.com/dealii/dealii/pull/14425

#14424: Print backends and architectures for Kokkos (proposed by masterleinad) 
https://github.com/dealii/dealii/pull/14424

#14423: Rename an inst file (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/14423

#14422: remove .cu extension in program2doxygen (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/14422

#14421: Further refactoring in data_out_base.cc (proposed by bangerth) 
https://github.com/dealii/dealii/pull/14421

#14420: De template AffineConstraints::add_entries_local_to_global() (proposed 
by drwells; merged) https://github.com/dealii/dealii/pull/14420

#14419: BlockSparsityPatternBase: inherit from SparsityPatternBase. (proposed 
by drwells; merged) https://github.com/dealii/dealii/pull/14419

#14418: TW sparsity pattern base (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/14418

#14417: Introduce 4th-kind Chebyshev preconditioner (proposed by peterrum) 
https://github.com/dealii/dealii/pull/14417

#14416: Fix vector access in SolverGMRES (proposed by peterrum) 
https://github.com/dealii/dealii/pull/14416

#14415: CMake: add a compile_test_executables target (proposed by tamiko; 
merged) https://github.com/dealii/dealii/pull/14415

#14414: Fix small typos in the intro.dox of Step-66 (proposed by lpsaavedra; 
merged) https://github.com/dealii/dealii/pull/14414

#14413: Fix FindGINKGO.cmake for Ginkgo 1.5.0 (proposed by tcojean; merged) 
https://github.com/dealii/dealii/pull/14413

#14411: Add an assertion. (proposed by bangerth) 
https://github.com/dealii/dealii/pull/14411

#14410: Remove comments that don't actually explain anything. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/14410

#14409: Do not mark functions in anonymous namespaces as 'static'. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/14409

#14408: Fix a mistake in the documentation. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/14408

#14407: Add a documentation note. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/14407

#14406: More refactoring of the VTU output. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/14406

#14404: CI: Update backports. (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/14404

#14402: Refactor compressing arrays for VTU output. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/14402

#14401: Minor fix to aid understand what a sentence means. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/14401

#14398: AffineConstraints: remove the block sparsity constraint function. 
(proposed by drwells; merged) https://github.com/dealii/dealii/pull/14398

#14397: Cleanup BSP (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/14397

#14396: (Dynamic)SparsityPattern: inherit from SparsityPatternBase. (proposed 
by drwells; merged) https://github.com/dealii/dealii/pull/14396

#14395: Fix a warning regarding unused variable (proposed by kronbichler; 
merged) https://github.com/dealii/dealii/pull/14395

#14394: minor doc fixes for KellyEstimator (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/14394

#14393: Add reference to dissertation in hp::Refinement namespace. (proposed by 
marcfehling; merged) https://github.com/dealii/dealii/pull/14393

#14392: Avoid boost::optional/variant in favor of std_cxx17::variant/optional. 
(proposed by bangerth) https://github.com/dealii/dealii/pull/14392

#14388: Add to the documentation of the ConsensusAlgorithms functions. 
(proposed by bangerth; merged) https://github.com/dealii/dealii/pull/14388

#14384: Add performance test showing compressible Navier-Stokes equations 
(proposed by kronbichler; merged) https://github.com/dealii/dealii/pull/14384

#14377: Move CUDA compilation to Kokkos with nvcc_wrapper (proposed by 
masterleinad; merged) https://github.com/dealii/dealii/pull/14377

#14355: Use Ubuntu 20.04 in GitHub actions (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/14355

#14352: Add TrilinosWrappers::SolverBelos (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/14352

#14328: Global coarsening: introduce embedded partitioner (proposed by 
peterrum; merged) https://github.com/dealii/dealii/pull/14328

#14323: GridTools::MarchingCubeAlgorithm: merge duplicate vertices in process() 
(proposed by mschreter; merged) https://github.com/dealii/dealii/pull/14323


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

#14430: Ghost particles are not generated across periodic boundaries (opened) 
https://github.com/dealii/dealii/issues/14430

#14426: Unify interfaces of data structures for Trilinos/Petsc/Deal (opened) 
https://github.com/dealii/dealii/issues/14426

#14412: Assert in FESubfaceValues() with triangles (adaptive mesh refinement) 
(opened) https://github.com/dealii/dealii/issues/14412

#14405: Potential deadlock in ConsensusAlgorithm::NBX on some systems (opened) 
https://github.com/dealii/dealii/issues/14405

#14403: Remove VtuStream class (opened) 
https://github.com/dealii/dealii/issues/14403

#14400: MGTranferMatrixFree custom constraints optimization (opened) 
https://github.com/dealii/dealii/issues/14400

#14399: compile error  when i enable the p4est . (opened) 
https://github.com/dealii/dealii/issues/14399


A list of all major changes since the last release can be found at 
https://www.dealii.org/developer/doxygen/deal.II/recent_changes.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.
To view this discussion on the web visit 
https://groups.google.com/d/msgid/dealii/63761464.1c0a0220.dacfb.b565SMTPIN_ADDED_MISSING%40gmr-mx.google.com.

Reply via email to