Hello everyone!

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

#15944: Fix some additional warnings (proposed by kronbichler) 
https://github.com/dealii/dealii/pull/15944

#15943: Make the p::s::T serialization test use zorder. (proposed by drwells) 
https://github.com/dealii/dealii/pull/15943

#15942: Use more 'if constexpr' in the matrix-free code. (proposed by drwells) 
https://github.com/dealii/dealii/pull/15942

#15941: FEEvaluation: Add some padding between different data fields (proposed 
by kronbichler) https://github.com/dealii/dealii/pull/15941

#15940: MatrixFree: Use constexpr when selecting evaluator factory (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/15940

#15939: Fix range-based for loop in performance test (proposed by kronbichler; 
merged) https://github.com/dealii/dealii/pull/15939

#15938: Fix assert (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/15938

#15937: Avoid switches in cuda_tensor_product_kernels.h (proposed by 
masterleinad; merged) https://github.com/dealii/dealii/pull/15937

#15936: Use range-based for loop for FEEvaluation's quadrature point loop 
(proposed by kronbichler; merged) https://github.com/dealii/dealii/pull/15936

#15935: Remove unnecessary code in a test (proposed by kronbichler; merged) 
https://github.com/dealii/dealii/pull/15935

#15934: Only use necessary vector_tools include file (proposed by kronbichler; 
merged) https://github.com/dealii/dealii/pull/15934

#15933: Avoid some loops that get never entered (proposed by kronbichler; 
merged) https://github.com/dealii/dealii/pull/15933

#15932: Add Functions::RayleighKotheVortex (proposed by peterrum) 
https://github.com/dealii/dealii/pull/15932

#15930: FEValues: Allow checking for cell similarities in multi-threaded mode 
(proposed by masterleinad) https://github.com/dealii/dealii/pull/15930

#15929: Fix indentation CI (proposed by kronbichler; merged) 
https://github.com/dealii/dealii/pull/15929

#15928: Introduce IndexSet::is_subset_of(). (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/15928

#15927: MGTwoLevelTransferNonNested: simplices with multiple components 
(proposed by peterrum) https://github.com/dealii/dealii/pull/15927

#15926: Remove unnecessary include file (proposed by kronbichler; merged) 
https://github.com/dealii/dealii/pull/15926

#15925: clang-format: Use QualifierAlignment: Left (proposed by masterleinad; 
merged) https://github.com/dealii/dealii/pull/15925

#15924: non_nested_multigrid_04 needs Trilinos (proposed by masterleinad; 
merged) https://github.com/dealii/dealii/pull/15924

#15923: VectorizedArray for ARM NEON (proposed by bergbauer; merged) 
https://github.com/dealii/dealii/pull/15923

#15922: Matrix-free Raviart-Thomas: Set symmetry/even-odd in ShapeInfo 
(proposed by kronbichler; merged) https://github.com/dealii/dealii/pull/15922

#15920: Add a new feature for 2nd order symmetric tensor split (proposed by 
taojinllnl) https://github.com/dealii/dealii/pull/15920

#15918: step-75: enable pseudo-3d solution (proposed by marcfehling; merged) 
https://github.com/dealii/dealii/pull/15918

#15917: Use common code for tensor product polynomial evaluation (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/15917

#15915: Tensor polynomials: Remove nonsensical comments (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/15915

#15914: MappingQ: don't require update_JxW_values or update_normal_vectors 
(proposed by peterrum; merged) https://github.com/dealii/dealii/pull/15914

#15913: Matrix-free ShapeInfo: Simplify initialization of Raviart-Thomas 
(proposed by kronbichler; merged) https://github.com/dealii/dealii/pull/15913

#15912: Fix for https://github.com/dealii/dealii/issues/15882 (proposed by 
stefanozampini; merged) https://github.com/dealii/dealii/pull/15912

#15911: Fix some failing tests (proposed by kronbichler; merged) 
https://github.com/dealii/dealii/pull/15911

#15909: Standardize on 'const X' instead of 'X const', part II (proposed by 
tamiko; merged) https://github.com/dealii/dealii/pull/15909

#15908: Standardize on 'const X' instead of 'X const'. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/15908

#15907: Disable eliminate_unrefined_islands in 
create_geometric_coarsening_sequence(). (proposed by marcfehling; merged) 
https://github.com/dealii/dealii/pull/15907

#15906: Add a default constructor to AffineConstraints. (And be more terse 
about default arguments.) (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/15906

#15905: MatrixFree ShapeInfo: Move some code to UnivariateShapeData (proposed 
by kronbichler; merged) https://github.com/dealii/dealii/pull/15905

#15904: Revert "PETScWrappers::TimeStepper: fix  typo" (proposed by tamiko) 
https://github.com/dealii/dealii/pull/15904

#15903: Infrastructure: Update bundled clang-format to version 16 (proposed by 
tamiko; merged) https://github.com/dealii/dealii/pull/15903

#15901: GlobalCoarseningFineDoFHandlerView: add assert (proposed by peterrum; 
merged) https://github.com/dealii/dealii/pull/15901

#15900: Always inline a new function to restore performance (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/15900

#15899: Expose RemotePointEvaluation parameters in non-nested multigrid 
(proposed by fdrmrc; merged) https://github.com/dealii/dealii/pull/15899

#15898: Be terser in specifying default arguments: ComponentMask. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/15898

#15897: CellIDTranslator: make Assert to AssertThrow (proposed by peterrum; 
merged) https://github.com/dealii/dealii/pull/15897

#15896: Introduce SmartPointer::get() (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/15896

#15895: Move the internal FEValuesViews functions into a new file. (proposed by 
drwells; merged) https://github.com/dealii/dealii/pull/15895

#15892: Non-nested transfer: add assert (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/15892

#15891: Restructure tensor-product kernels via 1d interpolants (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/15891

#15890: Use a relative tolerance. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/15890

#15889: Use if constexpr in some more places. (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/15889

#15888: Fix cuda_tensor_product_kernels.h (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/15888

#15886: Avoid using deprecated functions in timing_matrix_free_kokkos.cc 
(proposed by masterleinad; merged) https://github.com/dealii/dealii/pull/15886

#15885: Fix notebook: use list of Triangulation in merge_triangulations 
(proposed by Rombur; merged) https://github.com/dealii/dealii/pull/15885

#15884: Enable std::unique_ptr in MGSmootherRelaxation (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/15884

#15883: Matrix-free diagonal: Ensure constant loop bounds (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/15883

#15880: PETScWrappers::TimeStepper: fix  typo (proposed by stefanozampini; 
merged) https://github.com/dealii/dealii/pull/15880

#15879: Enable clang-tidy's bugprone-reserved-identifier check (proposed by 
sebproell) https://github.com/dealii/dealii/pull/15879

#15878: Modernize a test. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/15878

#15877: Clear some forgotten fields in Triangulation::clear(). (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/15877

#15876: Use target_link_options for link options (proposed by masterleinad; 
merged) https://github.com/dealii/dealii/pull/15876

#15863: Use Kokkos constructs in tensor product kernels when using Kokkos 4.0 
or later (proposed by Rombur; merged) 
https://github.com/dealii/dealii/pull/15863

#15843: FEPointEvaluation/MappingInfo for simplices (proposed by peterrum; 
merged) https://github.com/dealii/dealii/pull/15843

#15842: Add a version of timing_step_37 using MGTransferMF (proposed by 
peterrum; merged) https://github.com/dealii/dealii/pull/15842

#15820: MGTwoLevelTransferNonNested: enable simplex (proposed by peterrum; 
merged) https://github.com/dealii/dealii/pull/15820

#15807: MGTwoLevelTransfer: specialize setup for FCP and p-mg (proposed by 
peterrum; merged) https://github.com/dealii/dealii/pull/15807


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

#15931: Regression tester regressed 166861 (opened) 
https://github.com/dealii/dealii/issues/15931

#15921: Regression tester regressed 40a638 (opened and closed) 
https://github.com/dealii/dealii/issues/15921

#15919: New long compile times for grid_tools.cc? (opened and closed) 
https://github.com/dealii/dealii/issues/15919

#15916: Unable to compile deal ii with LAPACK provided by cray-libsci (opened) 
https://github.com/dealii/dealii/issues/15916

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

#15902: requires clauses with DEAL_II_CXX20_REQUIRES macro are barely readable 
(opened) https://github.com/dealii/dealii/issues/15902

#15894: MatrixFree: Reduce amount of compiled code for Hessians (opened) 
https://github.com/dealii/dealii/issues/15894

#15893: Regression tester regressed 1472e1 (opened and closed) 
https://github.com/dealii/dealii/issues/15893

#15887: Regression tester regressed 13fde3 (opened and closed) 
https://github.com/dealii/dealii/issues/15887

#15882: Regression tester regressed 53c9b4 (opened and closed) 
https://github.com/dealii/dealii/issues/15882

#15881: [New feature]: spectrum decomposition of a 2nd order symmetric tensor 
and 4th order projection tensors (opened) 
https://github.com/dealii/dealii/issues/15881

#15541: `FineDoFHandlerView` encounters cell that is neither locally nor 
remotely owned (closed) https://github.com/dealii/dealii/issues/15541


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/64ef67bd.050a0220.6b969.c1dbSMTPIN_ADDED_MISSING%40gmr-mx.google.com.

Reply via email to