Hello everyone!

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

#16695: MatrixFree: Fix function name in docu (proposed by bergbauer) 
https://github.com/dealii/dealii/pull/16695

#16694: Fix issue with colorized cylinder shell (proposed by blaisb) 
https://github.com/dealii/dealii/pull/16694

#16693: Tests: fix two headers (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/16693

#16691: `ParticleHandler`: use tolerance for is_inside_unit_cell() check 
(proposed by mschreter; merged) https://github.com/dealii/dealii/pull/16691

#16690: Fix typo one ':' between class names (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/16690

#16689: contrib/utilities/update-copyright.sh: several improvements (proposed 
by tamiko) https://github.com/dealii/dealii/pull/16689

#16687: Fix OpenCASCADE::*Boundary references to OpenCASCADE::*Manifold in 
step-54 docs (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/16687

#16686: Relicensing: update copyright header to intermediate format (proposed 
by tamiko; merged) https://github.com/dealii/dealii/pull/16686

#16685: Relicensing: update .mailmap (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/16685

#16683: Tpetra: Fix instantiations for SolverDirect* with complex number types 
(proposed by masterleinad; merged) https://github.com/dealii/dealii/pull/16683

#16682: GitHub CI: Also compile matrix_free_kokkos tests in CUDA CI (proposed 
by masterleinad; merged) https://github.com/dealii/dealii/pull/16682

#16681: Minor efficiency improvement. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/16681

#16680: Minor updates to the documentation of a few functions. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/16680

#16679: Tpetra: Fix compiling with complex values (proposed by masterleinad; 
merged) https://github.com/dealii/dealii/pull/16679

#16677: Add Tpetra SparseMatrix::matrix_scalar_product() and 
matrix_norm_square(). (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/16677

#16676: Tpetra: Add SparseMatrix::clear_row[s] (proposed by masterleinad; 
merged) https://github.com/dealii/dealii/pull/16676

#16675: Add function to retrieve a writable reference to particle locations 
(proposed by gassmoeller; merged) https://github.com/dealii/dealii/pull/16675

#16674: CMake: honor `optimized`,`debug`, and `general` keywords in `LIBRARIES` 
and `TARGETS` (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/16674

#16673: Fix `make_flux_sparsity_pattern` for `FENothing` (proposed by 
mschreter; merged) https://github.com/dealii/dealii/pull/16673

#16672: Tpetra: Implement Vector::is_non_negative (proposed by masterleinad; 
merged) https://github.com/dealii/dealii/pull/16672

#16670: Use size_type as return type of SparseMatrix::m(). (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/16670

#16669: Fix bundled boost 1.70.0 to avoid using std::unary_function (proposed 
by masterleinad; merged) https://github.com/dealii/dealii/pull/16669

#16668: Make LA::TpetraWrappers::SparseMatrix::copy_from compatible with older 
Trilinos versions. (proposed by kinnewig; merged) 
https://github.com/dealii/dealii/pull/16668

#16666: Relicensing: require all new contributions to be dual licensed 
(proposed by tamiko; merged) https://github.com/dealii/dealii/pull/16666

#16664: Add a comparison operator to LA::TpetraWrappers::Vector (proposed by 
kinnewig; merged) https://github.com/dealii/dealii/pull/16664

#16663: Declare conversion assignments for Tpetra vectors. (proposed by 
kinnewig; merged) https://github.com/dealii/dealii/pull/16663

#16661: Add python code for plotting in Step 3 (proposed by ampdes) 
https://github.com/dealii/dealii/pull/16661

#16660: Remove verbose output from Tpetra direct solver (proposed by jpthiele; 
merged) https://github.com/dealii/dealii/pull/16660

#16659: Update Trilinos readme. (proposed by marcfehling; merged) 
https://github.com/dealii/dealii/pull/16659

#16658: Find active cell around point simplices 9.5 (proposed by drwells; 
merged) https://github.com/dealii/dealii/pull/16658

#16657: Assert that we only extrude quadrilateral meshes. (proposed by drwells; 
merged) https://github.com/dealii/dealii/pull/16657

#16655: [9.5] take over pr #16653 (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/16655

#16654: Only enable a function if a template type is right. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/16654

#16653: Fix segmentation fault when using mpich (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/16653

#16651: Add the remaining SUNDIALS 7 output variants. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/16651

#16650: Add output variants for SUNDIALS 7. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/16650

#16649: Add missing <optional> header for trilinos_tpetra_vector.h (proposed by 
masterleinad; merged) https://github.com/dealii/dealii/pull/16649

#16648: Tpetra: Add frobenius_norm to SparseMatrix (proposed by masterleinad; 
merged) https://github.com/dealii/dealii/pull/16648

#16647: Add Tpetra tests that are already working. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/16647

#16646: Add info for TPLs to testsuite doc. (proposed by jpthiele; merged) 
https://github.com/dealii/dealii/pull/16646

#16645: SUNDIALS N_Vector: implement efficient operations (proposed by 
sebproell; merged) https://github.com/dealii/dealii/pull/16645

#16644: FE_NedelexSZ: Find hanging edges rework (proposed by kinnewig) 
https://github.com/dealii/dealii/pull/16644

#16641: Added complex sparse matrix instantiations. (proposed by 
MalikScheifinger; merged) https://github.com/dealii/dealii/pull/16641

#16637: Fix Tpetra vector element access. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/16637

#16633: MG transfer global coarsening: Avoid sending empty messages (proposed 
by kronbichler; merged) https://github.com/dealii/dealii/pull/16633

#16632: GridTools::compute_active_cell_halo_layer() for periodic meshes 
(proposed by peterrum; merged) https://github.com/dealii/dealii/pull/16632

#16629: GitHub CI: Test building with Trilinos+Tpetra (proposed by 
masterleinad; merged) https://github.com/dealii/dealii/pull/16629

#16602: Add SolverDirect for Tpetra Wrappers (proposed by jpthiele; merged) 
https://github.com/dealii/dealii/pull/16602

#16588: Add TpetraWrapper::BlockVector and TpetraWrappers::BlockSparseMatrix 
(proposed by kinnewig; merged) https://github.com/dealii/dealii/pull/16588

#16457: [C++23] When using C++23, use [[assume]] attribute. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/16457


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

#16692: Regression tester regressed b728a7 (opened and closed) 
https://github.com/dealii/dealii/issues/16692

#16688: Simplex grid refinement: How to avoid bad mesh quality (opened) 
https://github.com/dealii/dealii/issues/16688

#16684: Does MGTwoLevelTransfer work for any other vector than 
LinearAlgebra::distributed::Vector<Number>? (opened) 
https://github.com/dealii/dealii/issues/16684

#16678: Compilation fails on `ReadWriteVector` with Kokkos complex datatypes 
(opened and closed) https://github.com/dealii/dealii/issues/16678

#16671: Make Tpetra wrapper size_type definitions uniform. (opened) 
https://github.com/dealii/dealii/issues/16671

#16667: Regression tester regressed 2f6889 (opened and closed) 
https://github.com/dealii/dealii/issues/16667

#16665: Relicensing deal.II (opened) 
https://github.com/dealii/dealii/issues/16665

#16662: Issue of Boost `std::unary_function` on ARM-based mac with Clang 15 
(opened and closed) https://github.com/dealii/dealii/issues/16662

#16656: Regression tester regressed d7afa6 (opened and closed) 
https://github.com/dealii/dealii/issues/16656

#16652: Segmentation fault when running a program using mpich (opened and 
closed) https://github.com/dealii/dealii/issues/16652

#16643: Fix test pickup for `DEAL_II_TRILINOS_*` (opened and closed) 
https://github.com/dealii/dealii/issues/16643

#16642: Regression tester regressed 7f9acd (closed) 
https://github.com/dealii/dealii/issues/16642

#16635: Failure with Tpetra vectors: nonlocal_vector is not available. (closed) 
https://github.com/dealii/dealii/issues/16635

#16433: CMake: external boost with `debug` and `optimized` keywords is not 
split correctly into `_DEBUG|_RELEASE` library strings (closed) 
https://github.com/dealii/dealii/issues/16433

#14704: find_all_active_cells_around_point issue with simplex (closed) 
https://github.com/dealii/dealii/issues/14704

#9598: Memory consumption in large scale hp-adaptive applications. (closed) 
https://github.com/dealii/dealii/issues/9598


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/65dcc3c2.050a0220.efa06.1c42SMTPIN_ADDED_MISSING%40gmr-mx.google.com.

Reply via email to