[deal.II] deal.II Newsletter #281

2024-04-19 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

#16904: Use the same style of anchor name as elsewhere. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/16904

#16903: When creating a reference, use 'href', not 'name'. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/16903

#16902: Add VectorTraits to Trilinos and Tpetra wrappers (proposed by pcafrica; 
merged) https://github.com/dealii/dealii/pull/16902

#16900: Suppress some messages when normalizing test output. (proposed by 
bangerth) https://github.com/dealii/dealii/pull/16900

#16899: Print a message on the screen when normalizing a test output. (proposed 
by bangerth; merged) https://github.com/dealii/dealii/pull/16899

#16898: Fix use of incorrect Epetra function. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/16898

#16896: Non-nested MG transfer: Avoid repeated access of arrays (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/16896

#16895: Small improvement to RemotePointEvaluation (proposed by kronbichler; 
merged) https://github.com/dealii/dealii/pull/16895

#16894: Added changelog for #16879. (proposed by marcfehling; merged) 
https://github.com/dealii/dealii/pull/16894

#16892: Import the current development version of TaskFlow 3.7.0. (proposed by 
bangerth) https://github.com/dealii/dealii/pull/16892

#16891: FEPointEvaluation: Implement n_active_entries_per_quadrature_batch 
(proposed by bergbauer) https://github.com/dealii/dealii/pull/16891

#16889: Better document operator= for parallel vectors. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/16889

#16887: Add get_shape_value_component() to FE_NedelecSZ (proposed by kinnewig; 
merged) https://github.com/dealii/dealii/pull/16887

#16886: Add get_prolongation_matrix() to FE_NedelecSZ. (proposed by kinnewig; 
merged) https://github.com/dealii/dealii/pull/16886

#16885: Fix typo regarding templates in step 32 (proposed by quangx; merged) 
https://github.com/dealii/dealii/pull/16885

#16884: Un-hardcode 2d orientation. (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/16884

#16883: Add GridGenerator::cylinder/subdivided_cylinder/truncated_cone to the 
python wrappers (proposed by Rombur; merged) 
https://github.com/dealii/dealii/pull/16883

#16882: Don't define __ATOMIC_* in bundled Kokkos (proposed by masterleinad; 
merged) https://github.com/dealii/dealii/pull/16882

#16881: Clean up many explicit instantiations. (proposed by marcfehling; 
merged) https://github.com/dealii/dealii/pull/16881

#16880: Epetra vector access operator (proposed by pcafrica; merged) 
https://github.com/dealii/dealii/pull/16880

#16879: Compatibility with SUNDIALS 7. (proposed by marcfehling; merged) 
https://github.com/dealii/dealii/pull/16879

#16878: Step-90 TraceFEM tutorial (proposed by vyushut) 
https://github.com/dealii/dealii/pull/16878

#16876: Explicitly open HDF5 and then clear its floating-point exceptions. 
(proposed by drwells; merged) https://github.com/dealii/dealii/pull/16876

#16875: Fix a whole lot of typos. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/16875

#16874: Remove two exceptions that are apparently no longer used. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/16874

#16872: Mixed mesh orientation (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/16872

#16870: Update documentation for GridTools::distort_random(). (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/16870

#16869: Add DoFTools::extract_level_constant_modes() (proposed by peterrum; 
merged) https://github.com/dealii/dealii/pull/16869

#16854:  NonMatching::MappingInfo: Avoid memory allocations in reinit() 
(proposed by kronbichler; merged) https://github.com/dealii/dealii/pull/16854

#16726: Also change out_stream condition when enable/disable_output (proposed 
by RichardYCJ; merged) https://github.com/dealii/dealii/pull/16726

#16621: Import BOOST 1.84. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/16621

#15773: FECouplingValues. (proposed by luca-heltai; merged) 
https://github.com/dealii/dealii/pull/15773

#15572: Add InitFinalize base class of MPI_InitFinalize  (proposed by Rombur; 
merged) https://github.com/dealii/dealii/pull/15572


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

#16905: MG two-level `restrict_and_add` functionality (opened) 
https://github.com/dealii/dealii/issues/16905

#16901: `MappingManifold` does not support `update_hessians` and similar higher 
order mappings (opened) https://github.com/dealii/dealii/issues/16901

#16897: TrilinosWrappers::Vector calls 32-bit functions unconditionally. 
(opened and closed) https://github.com/dealii/dealii/issues/16897

#16893: 

[deal.II] deal.II Newsletter #280

2024-04-08 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

#16871: fix maybe-unused warning in grid_tools_dofhandler (proposed by tjhei) 
https://github.com/dealii/dealii/pull/16871

#16870: Update documentation for GridTools::distort_random(). (proposed by 
bangerth) https://github.com/dealii/dealii/pull/16870

#16869: Add DoFTools::extract_level_constant_modes() (proposed by peterrum) 
https://github.com/dealii/dealii/pull/16869

#16868: Remove redundant defaulted copy assignment operator for 
VectorizedArrayIterator (proposed by masterleinad) 
https://github.com/dealii/dealii/pull/16868

#16866: Small fixes in step-89 (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/16866

#16865: Vectorize class Tensor without requiring alignment or padding. 
(proposed by bangerth) https://github.com/dealii/dealii/pull/16865

#16864: Simplify some functions by just deferring to member functions. 
(proposed by bangerth; merged) https://github.com/dealii/dealii/pull/16864

#16863: Unclutter step-40's run() function. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/16863

#16862: In step-40, move timer section into the function being timed. (proposed 
by bangerth; merged) https://github.com/dealii/dealii/pull/16862

#16859: Remove debug output (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/16859

#16858: Test: cgal/cgal_mesh_criteria: disable floating point exceptions 
(proposed by tamiko; merged) https://github.com/dealii/dealii/pull/16858

#16857: Boost 1.80 (proposed by bangerth) 
https://github.com/dealii/dealii/pull/16857

#16856: Fix MG transfer for Tetrahedrons  (proposed by dominiktassilostill) 
https://github.com/dealii/dealii/pull/16856

#16855: Avoid std::pow in BarycentricPolynomials (proposed by kronbichler; 
merged) https://github.com/dealii/dealii/pull/16855

#16854:  NonMatching::MappingInfo: Avoid memory allocations in reinit() 
(proposed by kronbichler) https://github.com/dealii/dealii/pull/16854

#16853: Add Quadrature::initialize() function taking ArrayView (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/16853

#16852: MappingQ: Remove outdated documentation (proposed by kronbichler; 
merged) https://github.com/dealii/dealii/pull/16852

#16851: Import BOOST 1.83. (proposed by bangerth) 
https://github.com/dealii/dealii/pull/16851

#16850: Import BOOST 1.85 beta 1 (proposed by bangerth) 
https://github.com/dealii/dealii/pull/16850

#16849: Test fe/fe_values_view_{07|10|13|16}: make Assert more robust (proposed 
by tamiko; merged) https://github.com/dealii/dealii/pull/16849

#16848: Use vector intrinsics for tensor operations. (proposed by bangerth) 
https://github.com/dealii/dealii/pull/16848

#16847: MappingQ: Favor get_vertices() over compute_mapping_support_points() if 
possible (proposed by kronbichler; merged) 
https://github.com/dealii/dealii/pull/16847

#16845: Pass some SmartPointer variables by reference (proposed by kronbichler; 
merged) https://github.com/dealii/dealii/pull/16845

#16844: Use ArrayView for interface to tensor-product point evaluator (proposed 
by kronbichler; merged) https://github.com/dealii/dealii/pull/16844

#16843: VectorTools::interpolate: Make common case of vector problem faster 
(proposed by kronbichler; merged) https://github.com/dealii/dealii/pull/16843

#16841: Augment documentation of Utilities::type_to_string(). (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/16841

#16840: Vectorization type trait (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/16840

#16839: Make tensor*tensor implementation easier to read. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/16839

#16838: Mark DEAL_II_ALWAYS_INLINE functions as 'inline'. (proposed by 
bangerth) https://github.com/dealii/dealii/pull/16838

#16837: Provide an implementation for VectorizedArray::dot_product(). (proposed 
by bangerth; merged) https://github.com/dealii/dealii/pull/16837

#16836: Minor updates to VectorizedArray. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/16836

#16835: Fix ensure_single_trailing_newline() on macs. (proposed by drwells; 
merged) https://github.com/dealii/dealii/pull/16835

#16834: Export compile definitions for dependent targets (proposed by 
gassmoeller) https://github.com/dealii/dealii/pull/16834

#16833: Switch SolverFGMRES to new delayed classical Gram-Schmidt (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/16833

#16832: Fix naming of output files. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/16832

#16831: Fix two places where TriaAccessor::n_vertices is called repeatedly 
(proposed by kronbichler; merged) https://github.com/dealii/dealii/pull/16831

#16830: MappingCartesian: Some 

[deal.II] deal.II Newsletter #279

2024-04-01 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

#16825: Bump lukka/get-cmake from 3.27.9 to 3.29.0 (proposed by 
dependabot[bot]) https://github.com/dealii/dealii/pull/16825

#16823: Revert aligning tensors (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/16823

#16821: Deprecate some more (bool, bool, bool) orientation functions (proposed 
by drwells) https://github.com/dealii/dealii/pull/16821

#16820: distributed/tria.cc: avoid FPE due to undefined behavior (proposed by 
tamiko; merged) https://github.com/dealii/dealii/pull/16820

#16816: No longer output the size of tensors into output file of a test. 
(proposed by bangerth; merged) https://github.com/dealii/dealii/pull/16816

#16815: Fix a second place where particles compute the size of a buffer. 
(proposed by bangerth; merged) https://github.com/dealii/dealii/pull/16815

#16814: Add codimension in get_name() for a few elements (proposed by 
simonsticko; merged) https://github.com/dealii/dealii/pull/16814

#16813: Allocate the right amount of memory when serializing particles. 
(proposed by bangerth; merged) https://github.com/dealii/dealii/pull/16813

#16812: Test grid/closest_point: guard against roundoff error (proposed by 
tamiko; merged) https://github.com/dealii/dealii/pull/16812

#16811: Test trilinos/precondition: Relax iteration bounds (proposed by tamiko; 
merged) https://github.com/dealii/dealii/pull/16811

#16810: Test grid/grid_generator_09: add another output variant (proposed by 
tamiko; merged) https://github.com/dealii/dealii/pull/16810

#16809: Test mappings/mapping_q_real_to_unit_internal: add avx256 output 
variant (proposed by tamiko; merged) https://github.com/dealii/dealii/pull/16809

#16808: Test cgal/cgal_triangulation_05: add avx output variants (proposed by 
tamiko; merged) https://github.com/dealii/dealii/pull/16808

#16806: Remove hardcoded inverse orientation (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/16806

#16805: Add assert on reinit() being called before get_present_fe_values() 
(proposed by simonsticko; merged) https://github.com/dealii/dealii/pull/16805

#16804: Add a test for COMSOL .mphtxt triangle meshes. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/16804

#16803: Augment documentation of class Tensor. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/16803

#16802: Fix compilation of a test. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/16802

#16801: MappingQ: Do not assume contiguous storage of Tensor<2, dim> (proposed 
by kronbichler; merged) https://github.com/dealii/dealii/pull/16801

#16800: FEEvaluation: Modernize documentation of get_xxx/submit_xxx (proposed 
by kronbichler) https://github.com/dealii/dealii/pull/16800

#16799: Remove leftover author names in GridIn. (proposed by simonsticko; 
merged) https://github.com/dealii/dealii/pull/16799

#16798: Instantiate MappingC1 for dim <= spacedim (proposed by simonsticko; 
merged) https://github.com/dealii/dealii/pull/16798

#16797: `base/tensor.h`: make a statement a bit easier to read (proposed by 
tamiko; merged) https://github.com/dealii/dealii/pull/16797

#16795: Add three GridGenerator functions to the python wrappers (proposed by 
Rombur; merged) https://github.com/dealii/dealii/pull/16795

#16793: Fix CI using Kokkos+Cuda and CMake 3.28.4 and later (proposed by 
masterleinad; merged) https://github.com/dealii/dealii/pull/16793

#16791: Provide a better error message. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/16791

#16790: Remove/deprecate Tensor::begin/end_raw(). (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/16790

#16789: FEEvaluation: Ensure assertions in get_value/gradient are working 
(proposed by kronbichler; merged) https://github.com/dealii/dealii/pull/16789

#16788: FEEvaluation: Add static asserts to functions selected by enable_if 
(proposed by kronbichler; merged) https://github.com/dealii/dealii/pull/16788

#16787: FEEvaluation: Fix submit_gradient in 1D  (proposed by kronbichler; 
merged) https://github.com/dealii/dealii/pull/16787

#16785: CMake: fix OpenCASCADE-7.8 configure (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/16785

#16784: Fix compiler warning for macro usage in TpetraWrappers (proposed by 
masterleinad; merged) https://github.com/dealii/dealii/pull/16784

#16782: Fix test environment variables for OpenMPI 5. (proposed by drwells; 
merged) https://github.com/dealii/dealii/pull/16782

#16780: Consistent periodic orientation encoding (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/16780

#16776: FEEvaluation: Remove specialized Access class (proposed by kronbichler; 
merged) https://github.com/dealii/dealii/pull/16776

#16771: Align 

[deal.II] deal.II Newsletter #278

2024-03-25 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

#16781: Add local_range() and in_local_range() to LA::TpetraWrappers::Vector 
(proposed by kinnewig; merged) https://github.com/dealii/dealii/pull/16781

#16780: Consistent periodic orientation encoding (proposed by drwells) 
https://github.com/dealii/dealii/pull/16780

#16779: fix typo regarding schur preconditioner for step-32 (proposed by 
quangx; merged) https://github.com/dealii/dealii/pull/16779

#16778: Remove typo from step-26 intro.dox (proposed by KJSchwiebert; merged) 
https://github.com/dealii/dealii/pull/16778

#16776: FEEvaluation: Remove specialized Access class (proposed by kronbichler) 
https://github.com/dealii/dealii/pull/16776

#16775: Tensor product kernels: Implement generic operation for large sizes 
(proposed by kronbichler; merged) https://github.com/dealii/dealii/pull/16775

#16771: Align Tensor to make vectorization possible. (proposed 
by bangerth) https://github.com/dealii/dealii/pull/16771

#16770: FEEvaluation: Remove specialized access class for d=1,n_components=1 
(proposed by kronbichler; merged) https://github.com/dealii/dealii/pull/16770

#16769: FEEvaluation: Make sure that compiler can identify no-overlap of 
pointers (proposed by kronbichler; merged) 
https://github.com/dealii/dealii/pull/16769

#16768: Early deprecate FEEvaluation::get_normal_vector() (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/16768

#16767: PETSc: support version 3.21 (proposed by stefanozampini; merged) 
https://github.com/dealii/dealii/pull/16767

#16766: Augment assertions in TrilinosWrappers::*::SparseMatrix::add(). 
(proposed by bangerth; merged) https://github.com/dealii/dealii/pull/16766

#16765: FEPointEvaluation: Work towards dim < spacedim (proposed by 
kronbichler) https://github.com/dealii/dealii/pull/16765

#16764: Fix the spelling of a type in the documentation. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/16764

#16763: Make sure two cell iterator arguments lead to correct type deduction. 
(proposed by bangerth; merged) https://github.com/dealii/dealii/pull/16763

#16762: SolverGMRES: Improve documentation (proposed by kronbichler; merged) 
https://github.com/dealii/dealii/pull/16762

#16761: SolverGMRES: Skip work if x is all zero (proposed by kronbichler; 
merged) https://github.com/dealii/dealii/pull/16761

#16760: SolverGMRES: Switch default orthogonalization strategy to delayed CGS2 
(proposed by kronbichler; merged) https://github.com/dealii/dealii/pull/16760

#16759: Let `hp::Refinement::choose_p_over_h()` communicate future FE indices 
and refinement flags on all types of parallel Triangulation. (proposed by 
marcfehling) https://github.com/dealii/dealii/pull/16759

#16757: SolverGMRES: Fix a test case (proposed by kronbichler; merged) 
https://github.com/dealii/dealii/pull/16757

#16755: Improve refinement strategy for Tetrahedrons (proposed by 
dominiktassilostill; merged) https://github.com/dealii/dealii/pull/16755

#16754: Tensor product kernels: specialize a function for complex numbers 
(proposed by kronbichler; merged) https://github.com/dealii/dealii/pull/16754

#16753: Add `spacedim` template parameter of DoFHandler (proposed by mschreter; 
merged) https://github.com/dealii/dealii/pull/16753

#16752: Tensor product kernels: Remove unnecessary include files (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/16752

#16751: dealii::Vector: Simplify reset of vector size (proposed by kronbichler; 
merged) https://github.com/dealii/dealii/pull/16751

#16750: Fix uninitialized variable (proposed by kronbichler; merged) 
https://github.com/dealii/dealii/pull/16750

#16749: SolverGMRES: Implement classical Gram-Schmidt with delayed 
reorthogonalization (proposed by kronbichler; merged) 
https://github.com/dealii/dealii/pull/16749

#16748: Fix tests/performance/timing_mg_glob_coarsen.cc (proposed by 
masterleinad; merged) https://github.com/dealii/dealii/pull/16748

#16746: Update macro_check_compiler_setup.cmake to correct the conflict 
betwe... (proposed by BlueRain-debug) 
https://github.com/dealii/dealii/pull/16746

#16745: Cleanup of SolverGMRES and SolverFGMRES implementations (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/16745

#16744: SolverGMRES: Fix loop bound for orthogonalization (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/16744

#16742: PreconditionRelaxation: automatically determine omega (proposed by 
peterrum; merged) https://github.com/dealii/dealii/pull/16742

#16727: TrilinosWrappers::SolverDirect: adjust interface (proposed by peterrum; 
merged) https://github.com/dealii/dealii/pull/16727

#16714: Fix unintended terminate in gmsh-API version of read_msh (proposed by 
simonsticko; merged) 

[deal.II] deal.II Newsletter #277

2024-03-11 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

#16745: Cleanup of SolverGMRES and SolverFGMRES implementations (proposed by 
kronbichler) https://github.com/dealii/dealii/pull/16745

#16744: SolverGMRES: Fix loop bound for orthogonalization (proposed by 
kronbichler) https://github.com/dealii/dealii/pull/16744

#16743: Leave a couple comments in FETools. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/16743

#16742: PreconditionRelaxation: automatically determine omega (proposed by 
peterrum) https://github.com/dealii/dealii/pull/16742

#16741: In an internal function called from a virtual function, do not call 
virtual functions. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/16741

#16740: Tensor product tests: Fix include file (proposed by kronbichler; 
merged) https://github.com/dealii/dealii/pull/16740

#16738: Add support for OpenCascade 7.8.0 (proposed by thierry-FreeBSD; merged) 
https://github.com/dealii/dealii/pull/16738

#16736: MatrixFree: Split tensor product points and single point kernels 
(proposed by bergbauer; merged) https://github.com/dealii/dealii/pull/16736

#16735: Rename a few variables. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/16735

#16734: Implement VectorTools::interpolate_to_finer/coarser_mesh(). (proposed 
by bangerth; merged) https://github.com/dealii/dealii/pull/16734

#16733: Close the correct constraints objects. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/16733

#16732: Add the missing variants of TpetraWrappers::SparseMatrix::set(). 
(proposed by bangerth; merged) https://github.com/dealii/dealii/pull/16732

#16731: Fix Tpetra SparseMatrix::add(). (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/16731

#16730: Also remove the specialization structure of 
MGTwoLevelTransferNonNested. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/16730

#16729: Address a warning. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/16729

#16728: Tpetra: Fix warning in trilinos_tpetra_sparse_matrix.h (proposed by 
masterleinad) https://github.com/dealii/dealii/pull/16728

#16727: TrilinosWrappers::SolverDirect: adjust interface (proposed by peterrum) 
https://github.com/dealii/dealii/pull/16727

#16726: Also change out_stream condition when enable/disable_output (proposed 
by RichardYCJ) https://github.com/dealii/dealii/pull/16726

#16723: Make a specialization of MGTwoLevelTransfer the general template. 
(proposed by bangerth; merged) https://github.com/dealii/dealii/pull/16723

#16721: Matrix-free MG transfer: Switch interpolation matrices to double type 
(proposed by kronbichler; merged) https://github.com/dealii/dealii/pull/16721

#16720: Add necessary header files. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/16720

#16718: Fix a grammar error. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/16718

#16717: Make it possible to instantiate some matrix-free stuff for std::complex 
data. (proposed by bangerth; merged) https://github.com/dealii/dealii/pull/16717

#16716: vector_tools_interpolate.h: add a missing include (proposed by nmuch; 
merged) https://github.com/dealii/dealii/pull/16716

#16715: Improve an error message. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/16715

#16714: Fix unintended terminate in gmsh-API version of read_msh (proposed by 
simonsticko) https://github.com/dealii/dealii/pull/16714

#16713: Colorize hyper rectangle with simplices (proposed by nmuch; merged) 
https://github.com/dealii/dealii/pull/16713

#16709: Properly deregister a particle if deleted during refinement (proposed 
by gassmoeller; merged) https://github.com/dealii/dealii/pull/16709

#16704: Don't create new sections during parsing (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/16704

#16700: TpetraWrappers: Implement iterators for SparseMatrix (proposed by 
masterleinad; merged) https://github.com/dealii/dealii/pull/16700

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


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

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

#16737: deal.II does not support OpenCascade 7.8.0 (opened and closed) 
https://github.com/dealii/dealii/issues/16737

#16725: Add ConditionalOStream status change after initialization (opened) 
https://github.com/dealii/dealii/issues/16725

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

#16722: IntelLLVM cannot handle DEAL_II_RESTRICT keyword: internal compiler 
error in clang fronted 

[deal.II] deal.II Newsletter #276

2024-03-04 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

#16713: Colorize hyper rectangle with simplices (proposed by nmuch) 
https://github.com/dealii/dealii/pull/16713

#16711: Tpetra: Fix unity builds (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/16711

#16709: [WIP] Properly deregister a particle if deleted during refinement 
(proposed by gassmoeller) https://github.com/dealii/dealii/pull/16709

#16708: LICENSE.md: avoid "dual-license", clarify that licenses apply 
separately (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/16708

#16707: LA::p::Vector: Only initialize data on demand (proposed by kronbichler; 
merged) https://github.com/dealii/dealii/pull/16707

#16706: In step-40, say at least a little bit about parallel linear algebra. 
(proposed by bangerth; merged) https://github.com/dealii/dealii/pull/16706

#16705: Fix `hp::Refinement::limit_p_level_difference` for p-coarsening 
(proposed by marcfehling; merged) https://github.com/dealii/dealii/pull/16705

#16704: Don't create new sections during parsing (proposed by peterrum) 
https://github.com/dealii/dealii/pull/16704

#16703: Mailmap: add missing entries (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/16703

#16702: TpetraWrappers::SparseMatrix: Fix unused paramter in 
SparseMatrix::compress (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/16702

#16700: TpetraWrappers: Implement iterators for SparseMatrix (proposed by 
masterleinad) https://github.com/dealii/dealii/pull/16700

#16699: Mailmap: add missing entries (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/16699

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

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

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

#16614: Template TpetraWrappers::SparseMatrix::vmult on the vector type. 
(proposed by kinnewig; merged) https://github.com/dealii/dealii/pull/16614


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

#16712: Step-64 crash (opened) https://github.com/dealii/dealii/issues/16712

#16710: Compilation of `trilinos_tpetra_sparsity_pattern` fails when 
`DEAL_II_UNITY_BUILD=ON` (opened and closed) 
https://github.com/dealii/dealii/issues/16710

#16701: Regression tester regressed 1d56f8 (opened and closed) 
https://github.com/dealii/dealii/issues/16701

#16698: Problem: cmake 
-DCMAKE_INSTALL_PREFIX=/path/where/dealii/should/be/installed/to  
/path/to/dealii/sources (opened and closed) 
https://github.com/dealii/dealii/issues/16698


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/65e5fe20.050a0220.14cf7.36b5SMTPIN_ADDED_MISSING%40gmr-mx.google.com.


[deal.II] deal.II Newsletter #275

2024-02-26 Thread 'Rene Gassmoeller' via deal.II User Group
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

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

#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 

[deal.II] deal.II Newsletter #274

2024-02-13 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

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

#16640: Clarify the documentation of IndexSet::is_empty(). (proposed by 
bangerth) https://github.com/dealii/dealii/pull/16640

#16639: Declare conversion assignments for Tpetra vectors. (proposed by 
bangerth) https://github.com/dealii/dealii/pull/16639

#16638: Add missing changelog entry for colorize cylinder_shell (proposed by 
blaisb; merged) https://github.com/dealii/dealii/pull/16638

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

#16634: MPI compute index owner: improve documentation of flag (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/16634

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

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

#16631: ConsensusAlgorithmsPayload: switch internal data type (proposed by 
peterrum; merged) https://github.com/dealii/dealii/pull/16631

#16630: Add colorize option to cylinder_shell (proposed by blaisb; merged) 
https://github.com/dealii/dealii/pull/16630

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

#16628: Specify when Tpetra tests should be run (proposed by jpthiele; merged) 
https://github.com/dealii/dealii/pull/16628

#16626: Tpetra: Fix compiling with Trilinos versions prior to 13.2 (proposed by 
masterleinad; merged) https://github.com/dealii/dealii/pull/16626

#16625: Add tests for deal.II solvers with TpetraWrappers classes (proposed by 
jpthiele; merged) https://github.com/dealii/dealii/pull/16625

#16624: Enable MatrixCreator functions also for FullMatrix (proposed by 
peterrum) https://github.com/dealii/dealii/pull/16624

#16621: Import BOOST 1.84. (proposed by bangerth) 
https://github.com/dealii/dealii/pull/16621

#16620: Fix the name by which we reference an exception class. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/16620

#16619: FEFaceEvaluation + DG + hp: fix quadrature indexing (proposed by 
peterrum; merged) https://github.com/dealii/dealii/pull/16619

#16617: CMake: make sure that bundled include directory gets created (proposed 
by tamiko; merged) https://github.com/dealii/dealii/pull/16617

#16616: Tpetra: Implement operator(), el(), and diag_element() for SparseMatrix 
(proposed by masterleinad; merged) https://github.com/dealii/dealii/pull/16616

#16615: FlexibleIndexStorage: fix memory allocation (proposed by peterrum; 
merged) https://github.com/dealii/dealii/pull/16615

#16614: Template TpetraWrappers::SparseMatrix::vmult on the vector type. 
(proposed by kinnewig) https://github.com/dealii/dealii/pull/16614

#16613: Implementation for TpetraWrappers::Vector::operator Number() (proposed 
by kinnewig; merged) https://github.com/dealii/dealii/pull/16613

#16612: fix strip_comments target (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/16612

#16611: [WIP] Add Tpetra tests. (proposed by bangerth) 
https://github.com/dealii/dealii/pull/16611

#16610: Also instantiate the Trilinos Tpetra VectorReference class. (proposed 
by bangerth; merged) https://github.com/dealii/dealii/pull/16610

#16609: Fix 64-bit compilation with old PETSc versions. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/16609

#16608: Work around an issue in Teuchos::rcpFromRef() with types only forward 
declared. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/16608

#16607: Improve the error message we get for DEAL_II_ASSERT_UNREACHABLE(). 
(proposed by bangerth; merged) https://github.com/dealii/dealii/pull/16607

#16606: Fix compilation error arising with Intel ICC compiler in 
`trilinos_tpetra_sparsity_pattern.cc` (proposed by vovannikov; merged) 
https://github.com/dealii/dealii/pull/16606

#16604: Tpetra: Replace TrilinosScalar (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/16604

#16603: Fix deal.II CMake flag in Tpetra configure warning (proposed by 
jpthiele; merged) https://github.com/dealii/dealii/pull/16603

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

#16601: Better document a funny construct. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/16601

#16600: Convert tutorials to use DEAL_II_ASSERT_UNREACHABLE(). (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/16600

#16599: Explain how DEAL_II_ASSERT_UNREACHABLE() is used. (proposed 

[deal.II] deal.II Newsletter #273

2024-02-05 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

#16597: Tpetra: fix lac/vector_reinit_02 (proposed by masterleinad) 
https://github.com/dealii/dealii/pull/16597

#16596: NonMatching::MappingInfo: Remove quadrature projection (proposed by 
bergbauer) https://github.com/dealii/dealii/pull/16596

#16594: Better document problems with failed MPI I/O calls. (proposed by 
bangerth) https://github.com/dealii/dealii/pull/16594

#16593: More minor edits to tria_description.cc. (proposed by bangerth) 
https://github.com/dealii/dealii/pull/16593

#16592: Better document one aspect of what you can't do with ghosted vectors. 
(proposed by bangerth) https://github.com/dealii/dealii/pull/16592

#16591: Simplify some calls to make_array_view(). (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/16591

#16590: Enable a couple unit tests for LinearAlgebra::TpetraWrappers::Vector 
(proposed by masterleinad; merged) https://github.com/dealii/dealii/pull/16590

#16589: Suppress exception output that is not very interesting. (proposed by 
bangerth) https://github.com/dealii/dealii/pull/16589

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

#16587: Use correct function names in test (proposed by jh66637; merged) 
https://github.com/dealii/dealii/pull/16587

#16585: Simplify step-7 somewhat. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/16585

#16584: Fix mpi/local_size (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/16584

#16583: Use DEAL_II_CXX23_ASSERT in the Tensor class. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/16583

#16582: Require support for attribute [[assume]] for C++23 support (proposed by 
masterleinad; merged) https://github.com/dealii/dealii/pull/16582

#16581: Introduce DEAL_II_UNREACHABLE(). (proposed by bangerth) 
https://github.com/dealii/dealii/pull/16581

#16580: Add a missing template argument. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/16580

#16579: Provide an example of use for DEAL_II_NOT_IMPLEMENTED(). (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/16579

#16577: [main] take over point release changelog entry (proposed by tamiko; 
merged) https://github.com/dealii/dealii/pull/16577

#16576: [9.5] update changelog for point release (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/16576

#16575: [9.5] update changelog for point release (proposed by tamiko) 
https://github.com/dealii/dealii/pull/16575

#16574: Fix assert in import_elements from ReadWriteVector (proposed by 
kinnewig; merged) https://github.com/dealii/dealii/pull/16574

#16573: Minor doc update. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/16573

#16572: Convert a few more places of Assert(false, 
dealii::ExcNotImplemented()); (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/16572

#16571: More work in tria_description.h/cc. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/16571

#16569: Fix TpetraWrappers::SparsityPattern when compiling for GPU backends 
(proposed by masterleinad; merged) https://github.com/dealii/dealii/pull/16569

#16568: Use AlignedVector in ReadWriteVector. (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/16568

#16567: Fix a changelog entry that doxygen complains about. (proposed by 
bangerth) https://github.com/dealii/dealii/pull/16567

#16566: Prefer trilinos_vector over trilinos_rcp (proposed by masterleinad; 
merged) https://github.com/dealii/dealii/pull/16566

#16565: Template TrilinosWrappers::Vector on memory space (proposed by 
masterleinad; merged) https://github.com/dealii/dealii/pull/16565

#16564: Move the description of DeclException in step-9. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/16564

#16563: Explain the use of DEAL_II_NOT_IMPLEMENTED() in step-8. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/16563

#16562: Convert tutorial programs to use DEAL_II_NOT_IMPLEMENTED(). (proposed 
by bangerth; merged) https://github.com/dealii/dealii/pull/16562

#16560: Silence a warning. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/16560

#16559: Simplify the Copy-Constructor in TpetraWrappers::Vector (proposed by 
kinnewig; merged) https://github.com/dealii/dealii/pull/16559

#16558: Make a deep-copy of the Tpetra::Vector in the assignment operator. 
(proposed by kinnewig; merged) https://github.com/dealii/dealii/pull/16558

#16555: Testsuite: remove implicit target dependencies when possible (ninja 
support) (proposed by tamiko) https://github.com/dealii/dealii/pull/16555

#16551: Testsuite: use `./serial` 

[deal.II] deal.II Newsletter #272

2024-01-22 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

#16514: Bump actions/cache from 3 to 4 (proposed by dependabot[bot]; merged) 
https://github.com/dealii/dealii/pull/16514

#16513: Reenable assume macro (proposed by tamiko) 
https://github.com/dealii/dealii/pull/16513

#16512: DoFTools: Remove unnecessary template specializations (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/16512

#16510: Fix one more warning (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/16510

#16509: fix compiler warning (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/16509

#16506: Fix type in Tensor initialization. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/16506

#16505: Use simpler copy/move initialization in Tensor. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/16505

#16504: Use p[index] instead of p(index) for class Point in tests/. (proposed 
by bangerth; merged) https://github.com/dealii/dealii/pull/16504

#16503: Use p[index] instead of p(index) for class Point in one source file. 
(proposed by bangerth; merged) https://github.com/dealii/dealii/pull/16503

#16502: Disable DEAL_II(_CXX23)_ASSUME macro for now (proposed by tamiko; 
merged) https://github.com/dealii/dealii/pull/16502

#16501: Fix types and names in step-30. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/16501

#16500: Iterate space_dimension over the dedicated template argument list. 
(proposed by marcfehling; merged) https://github.com/dealii/dealii/pull/16500

#16499: base/tensor.h: work around bogus compiler warning (proposed by tamiko; 
merged) https://github.com/dealii/dealii/pull/16499

#16498: TpetraWrappers: fix various compiler warnings (proposed by tamiko; 
merged) https://github.com/dealii/dealii/pull/16498

#16497: Move matrix free classes from CUDAWrappers namespace to Portable 
namespace (proposed by Rombur) https://github.com/dealii/dealii/pull/16497

#16496: Enable `FE_DGQ::get_interpolation_matrix()` for source finite element 
type `FENothing` (proposed by mschreter; merged) 
https://github.com/dealii/dealii/pull/16496

#16495: tests: remove redundant 'using namespace dealii;' directives. (proposed 
by marcfehling; merged) https://github.com/dealii/dealii/pull/16495

#16494: DofTools: add missing codimension-one instantiation (proposed by 
tamiko; merged) https://github.com/dealii/dealii/pull/16494

#16490: Check if the global vector in distribute_local_to_global has ghost 
elements. (proposed by kinnewig; merged) 
https://github.com/dealii/dealii/pull/16490

#16489: fix bug in function DoFCellAccessor::distribute_local_to_global() 
(proposed by YiminJin; merged) https://github.com/dealii/dealii/pull/16489

#16488: Use p[index] instead of p(index) for class Point. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/16488

#16486: CMake: fix compilation with bundled boost and modern clang (proposed by 
tamiko; merged) https://github.com/dealii/dealii/pull/16486

#16485: Move DoFTools templates to templates.h header file (proposed by tamiko) 
https://github.com/dealii/dealii/pull/16485

#16482: Initialize NumberCache::n_global_active_cells (proposed by peterrum; 
merged) https://github.com/dealii/dealii/pull/16482

#16481: Work around warnings about invalid array accesses. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/16481

#16480: Use an array-of-scalars as the base case for Tensor. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/16480

#16478: exchange refinement flags: doc and changelog (proposed by tjhei; 
merged) https://github.com/dealii/dealii/pull/16478

#16477: Fix typo in changelog (proposed by kronbichler; merged) 
https://github.com/dealii/dealii/pull/16477

#16476: cell_categorization test: Adjust output (proposed by kronbichler; 
merged) https://github.com/dealii/dealii/pull/16476

#16474: Use a std::array instead of a C-style array for tensor elements. 
(proposed by bangerth; merged) https://github.com/dealii/dealii/pull/16474

#16473: More Tensor simplifications with if constexpr. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/16473

#16472: Fix a bug in function DoFCellAccessor::distribute_local_to_global() 
(proposed by YiminJin) https://github.com/dealii/dealii/pull/16472

#16471: test examples: support loading files (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/16471

#16470: CMake: print newline when vectorization is disabled. (proposed by 
tjhei; merged) https://github.com/dealii/dealii/pull/16470

#16468: Use if-constexpr more in Tensor. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/16468

#16467: Simplify Tensor::unroll(). (proposed by bangerth; merged) 

[deal.II] deal.II Newsletter #271

2023-12-27 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

#16385: Test examples (proposed by tjhei) 
https://github.com/dealii/dealii/pull/16385

#16382: FEPointEvaluation::integrate(): Only zero out relevant DoFs (proposed 
by jh66637) https://github.com/dealii/dealii/pull/16382

#16381: Fix spelling in a CI step. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/16381

#16380: Add reinit_faces() for Quadrature (proposed by jh66637) 
https://github.com/dealii/dealii/pull/16380

#16379: Use combined_orientation in two more FiniteElement functions. (proposed 
by drwells; merged) https://github.com/dealii/dealii/pull/16379

#16378: Prohibit calling compress() on vectors with ghost elements. (proposed 
by bangerth) https://github.com/dealii/dealii/pull/16378

#16377: More small updates to tria_description.cc. (proposed by bangerth) 
https://github.com/dealii/dealii/pull/16377

#16375: Fix an unused variable warning. (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/16375

#16374: Convert CreateDescriptionFromTriangulationHelper into a function. 
(proposed by bangerth) https://github.com/dealii/dealii/pull/16374

#16373: Use face_orientation to encode 2D orientation information. (proposed by 
drwells; merged) https://github.com/dealii/dealii/pull/16373

#16371: Introduce a function Utilities::MPI::partial_and_total_sum(). (proposed 
by bangerth; merged) https://github.com/dealii/dealii/pull/16371

#16370: Improve documentation of TriangulationDescription and members. 
(proposed by bangerth; merged) https://github.com/dealii/dealii/pull/16370

#16369: Some cleanups to create_description_from_triangulation(). (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/16369

#16368: Better document create_description_from_triangulation(). (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/16368

#16367: Choose a better name for a template argument. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/16367

#16365: Fix the names of functions in the documentation of step-42. (proposed 
by bangerth; merged) https://github.com/dealii/dealii/pull/16365

#16363: github-actions: simplify oneAPI setup with external action. (proposed 
by marcfehling) https://github.com/dealii/dealii/pull/16363

#16362: Bump actions/upload-artifact from 3 to 4 (proposed by dependabot[bot]; 
merged) https://github.com/dealii/dealii/pull/16362

#16361: Some more FEValuesBase cleanups (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/16361

#16359: Introduce FEFacePointEvaluation with optimized FCL path (proposed by 
bergbauer) https://github.com/dealii/dealii/pull/16359

#16358: Minor update to the introduction of step-41. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/16358

#16357: Choose a more efficient algorithm. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/16357

#16355: Use std::variant instead of a hand-rolled version. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/16355

#16354: Use a C++17 feature to make code more readable. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/16354

#16352: Correct a condition. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/16352

#16351: Do not create arrays we do not use. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/16351

#16350: Use std::optional instead of a hand-rolled version of it. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/16350

#16349: Disallow using direction flags for spacedim>dim+1. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/16349

#16347: Add a test for a recent patch. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/16347

#16239: KINSOL: option to select QR orthogonalization strategy (proposed by 
sebproell; merged) https://github.com/dealii/dealii/pull/16239

#16237: Actually fix Triangulation copydocs (proposed by jpthiele; merged) 
https://github.com/dealii/dealii/pull/16237


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

#16386: Regression tester regressed e7f6e8 (opened) 
https://github.com/dealii/dealii/issues/16386

#16384: step-14 segfaults in release mode (opened) 
https://github.com/dealii/dealii/issues/16384

#16383: step-9 crash in cycle 5 in release mode (opened) 
https://github.com/dealii/dealii/issues/16383

#16376: Communicator equality: same object vs. MPI_Comm_compare() (opened) 
https://github.com/dealii/dealii/issues/16376

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

#16366: deal.ii vector and block_vector interaction (opened and closed) 
https://github.com/dealii/dealii/issues/16366

#16364: 

[deal.II] deal.II Newsletter #270

2023-12-13 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

#16349: Disallow using direction flags for spacedim>dim+1. (proposed by 
bangerth) https://github.com/dealii/dealii/pull/16349

#16348: Add a changelog. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/16348

#16347: Add a test for a recent patch. (proposed by bangerth) 
https://github.com/dealii/dealii/pull/16347

#16345: Only set direction flags in the codim-1 case. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/16345

#16344: Do not query direction flags for Triangulation<1,3> objects. (proposed 
by bangerth; merged) https://github.com/dealii/dealii/pull/16344

#16342: Provide some context to an exception. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/16342

#16341: Make control flow easier to read. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/16341

#16340: MatrixFree::reinit: Fix case with MPI and threading (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/16340

#16339: MGTwoLevelTransfer: improve setup of indices (proposed by peterrum) 
https://github.com/dealii/dealii/pull/16339

#16338:  Support PETSc's new logging infrastructure in our test suite. 
(proposed by drwells; merged) https://github.com/dealii/dealii/pull/16338

#16336: Add failing test for multiple ranks and threads (proposed by jh66637; 
merged) https://github.com/dealii/dealii/pull/16336

#16335: Fix mistaken std::move assignment. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/16335

#16334: Leave a note in step-32. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/16334

#16330: exchange refinement flags (proposed by quangx) 
https://github.com/dealii/dealii/pull/16330

#16329: NOXSolver: add a test demonstrating the issue with pending_exception 
(proposed by vovannikov) https://github.com/dealii/dealii/pull/16329

#16328: Vectorize Function (proposed by bergbauer) 
https://github.com/dealii/dealii/pull/16328

#16327: make tests/mpi/affine_constraints_get_view_01 more robust (proposed by 
tjhei) https://github.com/dealii/dealii/pull/16327

#16325: Rewrite the introduction of step-5. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/16325

#16324: Fix name of a changelog file (proposed by mschreter; merged) 
https://github.com/dealii/dealii/pull/16324

#16323: RemotePointEvaluation: add AdditionalData struct (proposed by 
mschreter) https://github.com/dealii/dealii/pull/16323

#16322: MGTwoLevelTransfer: improve setup of weights (proposed by peterrum; 
merged) https://github.com/dealii/dealii/pull/16322

#16320: Fix the spelling of a function in the documentation. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/16320

#16319: fix a few comments in GridTools implementation (proposed by tjhei; 
merged) https://github.com/dealii/dealii/pull/16319

#16318: MatrixFree::get_face_iterator: Change assert (proposed by bergbauer; 
merged) https://github.com/dealii/dealii/pull/16318

#16317: MatrixFree: check that JxW is not negative (proposed by peterrum) 
https://github.com/dealii/dealii/pull/16317

#16316: disable nvcc Kokkos warnings (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/16316

#16315: unify some example output (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/16315

#16314: Evaluation template factory: Remove unused template (proposed by 
bergbauer; merged) https://github.com/dealii/dealii/pull/16314

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

#16310: Disable the PETSc reference counting check for 3.20 and newer. 
(proposed by drwells; merged) https://github.com/dealii/dealii/pull/16310

#16309: Remove CITATIONS.bib (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/16309

#16306: Make the elements of FEValuesViews::Cache lazily constructed. (proposed 
by bangerth; merged) https://github.com/dealii/dealii/pull/16306

#16305: Better place a set of parentheses. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/16305

#16304: Add support for hanging nodes to the NedelecSZ class. (proposed by 
kinnewig) https://github.com/dealii/dealii/pull/16304

#16303: Add preferred citation to CFF (proposed by jpthiele) 
https://github.com/dealii/dealii/pull/16303

#16302: Set CMP0074 to NEW in CMakeLists (proposed by jpthiele; merged) 
https://github.com/dealii/dealii/pull/16302

#16301: Replace content of MGTransferMatrixFree by that of MGTransferMF 
(proposed by peterrum) https://github.com/dealii/dealii/pull/16301

#16300: Classes used by Step 89  (proposed by jh66637) 
https://github.com/dealii/dealii/pull/16300

#16299: Add tutorial on Nitsche-type mortaring (proposed by jh66637) 

[deal.II] deal.II Newsletter #269

2023-11-13 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

#16265: Look-up table for Hermite (proposed by ivweber) 
https://github.com/dealii/dealii/pull/16265

#16264: Fix table of content anchors in tutorials (proposed by jpthiele) 
https://github.com/dealii/dealii/pull/16264

#16263: SymmetricTensor: Minimize number of instructions for multiply by Tensor 
(proposed by kronbichler; merged) https://github.com/dealii/dealii/pull/16263

#16262: Fix an equation in the tutorial of step-41 (proposed by taojinllnl; 
merged) https://github.com/dealii/dealii/pull/16262

#16261: Symmetric tensor cleanup (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/16261

#16260: Document constructors and copy/move operators of Threads::Task. 
(proposed by bangerth) https://github.com/dealii/dealii/pull/16260

#16259: Erronius VectorTools::NormType::* has been replaced with 
VectorTools:... (proposed by vyushut; merged) 
https://github.com/dealii/dealii/pull/16259

#16258: Add a changelog entry. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/16258

#16257: Add another static assertion on exception types. (proposed by drwells; 
merged) https://github.com/dealii/dealii/pull/16257

#16255: Make an assertion more informative. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/16255

#16254: Add constexpr to Point ctor and member functions with unit test 
(proposed by RichardYCJ) https://github.com/dealii/dealii/pull/16254

#16253: Fix clang-tidy-17 complains (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/16253

#16252: Fix `active_fe_index` query to consider cell categorization (proposed 
by davidscn) https://github.com/dealii/dealii/pull/16252

#16251: Add constexpr to Point and remove redundant operator (proposed by 
RichardYCJ) https://github.com/dealii/dealii/pull/16251

#16248: Rename internal functions. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/16248

#16247: Add some missing headers to grid_tools_topology.h. (proposed by 
drwells; merged) https://github.com/dealii/dealii/pull/16247

#16246: Update some more documentation to refer to our C++17 requirement. 
(proposed by drwells; merged) https://github.com/dealii/dealii/pull/16246

#16245: Remove workarounds for Assert* in tensor.h (proposed by masterleinad; 
merged) https://github.com/dealii/dealii/pull/16245

#16244: Clarify when RemotePointEvaluation is reinitialized. (proposed by 
drwells; merged) https://github.com/dealii/dealii/pull/16244

#16242: Make a function not 'virtual'. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/16242

#16240: Use the standard form of lambda expressions. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/16240

#16239: KINSOL: option to select QR orthogonalization strategy (proposed by 
sebproell) https://github.com/dealii/dealii/pull/16239

#16237: Actually fix Triangulation copydocs (proposed by jpthiele) 
https://github.com/dealii/dealii/pull/16237

#16236: Extend assert message of `GridTools::exchange_cell_data()` (proposed by 
mschreter; merged) https://github.com/dealii/dealii/pull/16236

#16234: Remove `hp::DoFHandler` from doxygen headers. (proposed by marcfehling; 
merged) https://github.com/dealii/dealii/pull/16234

#16233: Update the documentation of SmartPointer. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/16233

#16232: Document how to impose boundary values on individual vertices. 
(proposed by bangerth; merged) https://github.com/dealii/dealii/pull/16232

#16231: Release tbb::task_group data early. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/16231

#16230: Better structure some code in the gmsh wrappers. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/16230

#16229: Replace ACCESSOR -> AccessorType. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/16229

#16228: Replace ACCESSOR -> AccessorType and related changes. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/16228

#16227: Replace ITERATOR -> IteratorType. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/16227

#16226: Remove an unnecessary friend declaration. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/16226

#16225: Make sure we declare the correct classes as 'friend'. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/16225

#16224: Fix use of flags in CUDAWrappers::MatrixFree (proposed by peterrum; 
merged) https://github.com/dealii/dealii/pull/16224

#16223: Minor code updates to GrowingVectorMemory. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/16223

#16222: Better describe a mutex. (proposed by bangerth; merged) 

[deal.II] deal.II Newsletter #268

2023-10-04 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

#16090: FEPointEvaluation: Fix check in debug mode (proposed by bergbauer) 
https://github.com/dealii/dealii/pull/16090

#16089: DerivativeForm output operator: Add test and changelog (proposed by 
bergbauer) https://github.com/dealii/dealii/pull/16089

#16088: MGTransferMF: check compatibility of DoFHandlers (proposed by peterrum) 
https://github.com/dealii/dealii/pull/16088

#16086: Swap out burn() for sleep in an erratic test. (proposed by drwells; 
merged) https://github.com/dealii/dealii/pull/16086

#16085: Fix initialize typo in global coarsening functions (proposed by 
lpsaavedra; merged) https://github.com/dealii/dealii/pull/16085

#16083: Document the intention of the numbers::invalid_* variables. (proposed 
by bangerth) https://github.com/dealii/dealii/pull/16083

#16082: Print function for DerivativeForm (proposed by bergbauer; merged) 
https://github.com/dealii/dealii/pull/16082

#16081: NonMatching::MappingInfo: Adjust tolerance for GeometryType detection 
(proposed by bergbauer) https://github.com/dealii/dealii/pull/16081

#16080: Fix NoncontiguousPartitioner::import_from_ghosted_array() (proposed by 
peterrum; merged) https://github.com/dealii/dealii/pull/16080

#16079: Add a function to take a view of an index set with regard to an index 
set mask. (proposed by bangerth) https://github.com/dealii/dealii/pull/16079

#16078: Reduce overhead in FEEvaluation::reinit(array of cells) (proposed by 
bergbauer; merged) https://github.com/dealii/dealii/pull/16078

#16076: Restructure FullMatrix::invert to (hopefully) lower compilation times 
(proposed by kronbichler; merged) https://github.com/dealii/dealii/pull/16076

#16075: github-actions: fix a race condition. (proposed by marcfehling; merged) 
https://github.com/dealii/dealii/pull/16075

#16074: GitHub CI OSX and Windows: Upload CMakeConfigureLog (proposed by 
masterleinad; merged) https://github.com/dealii/dealii/pull/16074

#16073: Update oneAPI CI (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/16073

#16072: Add step-87: Tutorial on RemotePointEvaluation (proposed by peterrum) 
https://github.com/dealii/dealii/pull/16072

#16071: Docker: fix order of ARGS in Dockerfile. (proposed by marcfehling; 
merged) https://github.com/dealii/dealii/pull/16071

#16069: Fix Doxygen copydoc references (proposed by jpthiele) 
https://github.com/dealii/dealii/pull/16069

#16068: make_flux_sparsity_pattern: Reduce compile time by joining code 
(proposed by kronbichler; merged) https://github.com/dealii/dealii/pull/16068

#16067: Doxygen/Tutorials remove unnecessary anchors (proposed by jpthiele) 
https://github.com/dealii/dealii/pull/16067

#16066: Fix doxygen warnings for template instantiations (proposed by jpthiele; 
merged) https://github.com/dealii/dealii/pull/16066

#16064: Minor cleanups. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/16064

#16063: Docker: Build images every 12 hours. (proposed by marcfehling; merged) 
https://github.com/dealii/dealii/pull/16063

#16062: Docker: Build images with different number of jobs. (proposed by 
marcfehling; merged) https://github.com/dealii/dealii/pull/16062

#16061: Docker: Use the default driver again. (proposed by marcfehling; merged) 
https://github.com/dealii/dealii/pull/16061

#16060: Docker: Use one process to decrease memory usage. (proposed by 
marcfehling; merged) https://github.com/dealii/dealii/pull/16060

#16059: More assertions in AffineConstraints. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/16059

#16058: Use gmres in step 12 (proposed by nils-schween) 
https://github.com/dealii/dealii/pull/16058

#16057: Remove commented code (proposed by peterrum) 
https://github.com/dealii/dealii/pull/16057

#16056: MGTwoLevelTransfer: different improvements (proposed by peterrum) 
https://github.com/dealii/dealii/pull/16056

#16055: Fix .pl extensions in copyright update script (proposed by jpthiele; 
merged) https://github.com/dealii/dealii/pull/16055

#16054: Matrix-free kernels: Try to fix Cuda warning (proposed by kronbichler; 
merged) https://github.com/dealii/dealii/pull/16054

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

#16052: WIP: Replace epetra with tpetra (proposed by kinnewig) 
https://github.com/dealii/dealii/pull/16052

#16051: Fix Doxygen warnings for anchors (proposed by jpthiele; merged) 
https://github.com/dealii/dealii/pull/16051

#16050: MappingDataOnTheFly: make FE_Nothing unique_ptr (proposed by peterrum; 
merged) https://github.com/dealii/dealii/pull/16050

#16049: MGTwoLevelTransfer: refine DG check (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/16049

#16048: Rename perl scripts to include .pl as 

[deal.II] deal.II Newsletter #267

2023-09-15 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

#15990: Simplify some code. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/15990

#15986: Add QGaussRadau quadrature formula + tests (proposed by jpthiele; 
merged) https://github.com/dealii/dealii/pull/15986

#15983: Matrix-free: Split up evaluation_kernels.h into cell and face parts 
(proposed by kronbichler; merged) https://github.com/dealii/dealii/pull/15983

#15982: [WIP] Introduce FERemoteEvaluation (proposed by jh66637) 
https://github.com/dealii/dealii/pull/15982

#15981: Matrix-free FEEvaluation: Avoid indirection in call to sum 
factorization (proposed by kronbichler; merged) 
https://github.com/dealii/dealii/pull/15981

#15980: Optimize arithmetic operations for Raviart-Thomas elements (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/15980

#15978: Bump actions/checkout from 3 to 4 (proposed by dependabot[bot]; merged) 
https://github.com/dealii/dealii/pull/15978

#15977: Fix address boundary error in FEInterfaceValues::get_update_flags() 
(proposed by simonsticko; merged) https://github.com/dealii/dealii/pull/15977

#15976: Do not use deprecated extract_locally_* functions in library. (proposed 
by marcfehling; merged) https://github.com/dealii/dealii/pull/15976

#15974: Implement AlignedVector::shrink_to_fit() (proposed by bergbauer) 
https://github.com/dealii/dealii/pull/15974

#15973: Update the count_lines.sh script. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/15973

#15972: Implement StridedArrayView (proposed by bergbauer) 
https://github.com/dealii/dealii/pull/15972

#15971: Optimize FEPointEvaluation/NM::MappingInfo (proposed by bergbauer) 
https://github.com/dealii/dealii/pull/15971

#15970: Augment error message for clang-format. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/15970

#15969: Add a reference to an article. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/15969

#15968: Allow comparison of IndexSet objects against default-constructed 
objects. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/15968

#15967: Avoid using a deprecated function. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/15967

#15966: Mark deprecated functions with DEAL_II_DEPRECATE_EARLY. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/15966

#15965: Matrix-free shape info: Generate face orientation table for R-T 
(proposed by kronbichler; merged) https://github.com/dealii/dealii/pull/15965

#15964: Matrix-free for Raviart-Thomas: Test correct interpolation (non-affine) 
(proposed by kronbichler; merged) https://github.com/dealii/dealii/pull/15964

#15963: FE_PolyTensor: Only request dof_sign_change if necessary (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/15963

#15962: Remove static declaration from a few tests (proposed by kronbichler; 
merged) https://github.com/dealii/dealii/pull/15962

#15961: Add step-87: Tutorial on RemotePointEvaluation (proposed by mschreter) 
https://github.com/dealii/dealii/pull/15961

#15960: Update shasum for clang-format mac. (proposed by luca-heltai; merged) 
https://github.com/dealii/dealii/pull/15960

#15954: Another attempt to fix compile warning (proposed by kronbichler; 
merged) https://github.com/dealii/dealii/pull/15954

#15952: Added another test for limit_p_level_difference(). (proposed by 
marcfehling; merged) https://github.com/dealii/dealii/pull/15952

#15951: Matrix-free evaluation of Raviart-Thomas: major restructuring (proposed 
by kronbichler; merged) https://github.com/dealii/dealii/pull/15951

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


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

#15989: Regression tester regressed e8073d (opened) 
https://github.com/dealii/dealii/issues/15989

#15988: Further optimize AffineConstraints::distribute() with partitioners. 
(opened) https://github.com/dealii/dealii/issues/15988

#15987: Add check in AffineConstraints that user provided index set arguments 
when running in parallel. (opened) https://github.com/dealii/dealii/issues/15987

#15985: Make transfinite interpolation more accessible (opened) 
https://github.com/dealii/dealii/issues/15985

#15984: Step-12 Solver should use SolverGMRES (opened) 
https://github.com/dealii/dealii/issues/15984

#15979: Tpetra wrapper (opened) https://github.com/dealii/dealii/issues/15979

#15975: Fix hard-to-read code in dof_renumbering.cc. (opened and closed) 
https://github.com/dealii/dealii/issues/15975

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

#15894: 

[deal.II] deal.II Newsletter #266

2023-09-06 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

#15960: Update shasum for clang-format mac. (proposed by luca-heltai) 
https://github.com/dealii/dealii/pull/15960

#15959: MatrixFree: do not update ghost values of a ghosted src vector 
(proposed by peterrum) https://github.com/dealii/dealii/pull/15959

#15958: Simplify some GridTools functions. (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/15958

#15956: Unify headers of tutorials (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/15956

#15955: fix check_compiler_setup failed build issue mentioned in #1921  
(proposed by RoadToDream) https://github.com/dealii/dealii/pull/15955

#15954: Another attempt to fix compile warning (proposed by kronbichler) 
https://github.com/dealii/dealii/pull/15954

#15953: Add an assertion to IndexSet::compress(). (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/15953

#15952: Added another test for limit_p_level_difference(). (proposed by 
marcfehling) https://github.com/dealii/dealii/pull/15952

#15951: Matrix-free evaluation of Raviart-Thomas: major restructuring (proposed 
by kronbichler) https://github.com/dealii/dealii/pull/15951

#15950: FEEvaluation for Raviart-Thomas: use fewer multiplications (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/15950

#15949: Also run check for symmetry for fe_degree = 0 (proposed by kronbichler; 
merged) https://github.com/dealii/dealii/pull/15949

#15948: Add matrix-free interpolation test for Raviart-Thomas case (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/15948

#15947: Added one assertion to setup_line_to_cell. (proposed by marcfehling; 
merged) https://github.com/dealii/dealii/pull/15947

#15945: Add code to serialize PETSc vectors. (proposed by drwells) 
https://github.com/dealii/dealii/pull/15945

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

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

#15865: reset ghost state in MG_transfer_global_coarsening interpolate 
(proposed by richardschu; merged) https://github.com/dealii/dealii/pull/15865


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

#15957: Tracking deal.ii in downstream package repositories (opened) 
https://github.com/dealii/dealii/issues/15957

#15946: CMake: use pkgconfig information when available (opened) 
https://github.com/dealii/dealii/issues/15946


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/64f8a217.2e0a0220.6d259.bf6eSMTPIN_ADDED_MISSING%40gmr-mx.google.com.


[deal.II] deal.II Newsletter #265

2023-08-30 Thread 'Rene Gassmoeller' via deal.II User Group
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) 

[deal.II] deal.II Newsletter #264

2023-08-14 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

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

#15875: SIMD: Allow to switch off vectorized gather/scatter (proposed by 
kronbichler) https://github.com/dealii/dealii/pull/15875

#15874: Fix bug in AffineConstraints::shift (proposed by luca-heltai; merged) 
https://github.com/dealii/dealii/pull/15874

#15872: Documentation of `DataOutResample`: fix formatting (proposed by 
mschreter; merged) https://github.com/dealii/dealii/pull/15872

#15871: Don't display vertices of bboxes when testing (proposed by fdrmrc; 
merged) https://github.com/dealii/dealii/pull/15871

#15870: Don't use implementation-reserved double underscores (proposed by 
sebproell; merged) https://github.com/dealii/dealii/pull/15870

#15868: Use iterative implementation for Utilities::pow to support Intel GPUs 
(proposed by masterleinad; merged) https://github.com/dealii/dealii/pull/15868

#15867: MatrixFree setup: Reduce cost of vector access pattern computation 
(proposed by kronbichler; merged) https://github.com/dealii/dealii/pull/15867

#15866: Matrix-free renumbering: Avoid sorting (proposed by kronbichler; 
merged) https://github.com/dealii/dealii/pull/15866

#15865: reset ghost state in MG_transfer_global_coarsening interpolate 
(proposed by richardschu) https://github.com/dealii/dealii/pull/15865

#15864: Making hanging constraints: Reduce number of memory allocations 
(proposed by kronbichler; merged) https://github.com/dealii/dealii/pull/15864

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

#15862: Fix issue when compiling with HIP (proposed by Rombur; merged) 
https://github.com/dealii/dealii/pull/15862

#15861: Remove not needed virtual (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/15861

#15859: MatrixFree fast hanging node constraints: simplify a check (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/15859

#15858: MatrixFree hanging nodes: reduce memory allocations for line setup 
(proposed by kronbichler; merged) https://github.com/dealii/dealii/pull/15858

#15857: Avoid memory allocation in CellIDTranslator (proposed by kronbichler; 
merged) https://github.com/dealii/dealii/pull/15857

#15856: [9.5] Fix compiling with PETSc with complex scalar type (proposed by 
masterleinad; merged) https://github.com/dealii/dealii/pull/15856

#15852: Fix compiling with PETSc with complex scalar type (proposed by 
masterleinad; merged) https://github.com/dealii/dealii/pull/15852

#15851: Multiple components in MGTwoLevelTransferNonNested (proposed by fdrmrc; 
merged) https://github.com/dealii/dealii/pull/15851

#15849: PETScWrappers:Align SNES with TS in comments and Jacobian handling 
(proposed by stefanozampini; merged) https://github.com/dealii/dealii/pull/15849

#15806: Add NodeVisitor in rtree.h (proposed by fdrmrc; merged) 
https://github.com/dealii/dealii/pull/15806

#15803: NonMatching:  Add support for FE_Q_iso_Q1 to MeshClassifier and 
Discrete(Face)QuadratureGenerator (proposed by bergbauer; merged) 
https://github.com/dealii/dealii/pull/15803


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

#15873: Performance regression: Intel GDS mitigation (aka Downfall) (opened) 
https://github.com/dealii/dealii/issues/15873

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

#15860: test issue via API (opened and closed) 
https://github.com/dealii/dealii/issues/15860

#15855: Linker error on M1 ARM with MPI in MGTwoLevelTransferBase (opened) 
https://github.com/dealii/dealii/issues/15855

#15847: Build Failure with PETSC-Complex, Invalid Static Cast (closed) 
https://github.com/dealii/dealii/issues/15847

#15840: Regression tester regressed 2e55d7 (closed) 
https://github.com/dealii/dealii/issues/15840

#15834: ./candi.sh   Exit message: There was a problem building dealii v9.5.1. 
(closed) https://github.com/dealii/dealii/issues/15834


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" 

[deal.II] deal.II Newsletter #263

2023-08-07 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

#15854: Fix typo (proposed by peterrum) 
https://github.com/dealii/dealii/pull/15854

#15853: Test petsc/petsc_ts_03: add output variant for 3.15.5 (proposed by 
tamiko) https://github.com/dealii/dealii/pull/15853

#15852: Fix compiling with PETSc with complex scalar type (proposed by 
masterleinad) https://github.com/dealii/dealii/pull/15852

#15851: Multiple components in MGTwoLevelTransferNonNested (proposed by fdrmrc) 
https://github.com/dealii/dealii/pull/15851

#15850: No longer list IWR as the hosting institution. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/15850

#15849: PETScWrappers:Align SNES with TS in comments and Jacobian handling 
(proposed by stefanozampini) https://github.com/dealii/dealii/pull/15849

#15845: petsc_ts_03: need to add an output for pre 3.20 (proposed by 
stefanozampini; merged) https://github.com/dealii/dealii/pull/15845

#15844: Test petsc/petsc_ts_03: update test output (proposed by tamiko) 
https://github.com/dealii/dealii/pull/15844

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

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

#15841: MGTwoLevelTransfer: remove temporal vector in compute_weights() 
(proposed by peterrum; merged) https://github.com/dealii/dealii/pull/15841

#15838: Add Functions::FunctionUnitToReal. (proposed by simonsticko) 
https://github.com/dealii/dealii/pull/15838

#15832: Avoid memory allocations in step 68 (proposed by gassmoeller; merged) 
https://github.com/dealii/dealii/pull/15832

#15829: Split fe_values.h and fe_values.cc into three files each. (proposed by 
drwells; merged) https://github.com/dealii/dealii/pull/15829

#15826: Fix a build warning (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/15826

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

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

#15819: FEValuesViews::ReorderedView (proposed by luca-heltai) 
https://github.com/dealii/dealii/pull/15819

#15817: Introduce Triangulation::as_dof_handler_level_iterator() (proposed by 
peterrum; merged) https://github.com/dealii/dealii/pull/15817

#15816: Introduce Triangulation::contains_cell() (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/15816

#15815: Add NoncontiguousPartitioner::import_from_ghosted_array() (proposed by 
peterrum; merged) https://github.com/dealii/dealii/pull/15815

#15812: Add constrained entries to partitioner_coarse in NonNestedMG (proposed 
by fdrmrc; merged) https://github.com/dealii/dealii/pull/15812

#15811: GridTools::find_active_cell_around_point() and 
find_all_active_cells_around_point() for simplices (proposed by peterrum; 
merged) https://github.com/dealii/dealii/pull/15811

#15810: GT::vertex_to_cell_map(): check if triangulation is locally refined. 
(proposed by peterrum; merged) https://github.com/dealii/dealii/pull/15810

#15808: Use Cache::get_vertex_to_cell_map() in 
GT::find_all_locally_owned_act... (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/15808

#15805: Added gradient() evaluation to VectorFunctionFromTensorFunction 
(proposed by AbbBallout; merged) https://github.com/dealii/dealii/pull/15805

#15802: Adjust expectations in a GridTools::get_coarse_mesh_description(). 
(proposed by bangerth; merged) https://github.com/dealii/dealii/pull/15802

#15801: Make GridGenerator::hyper_cube_with_cylindrical_hole<2>() more robust. 
(proposed by bangerth; merged) https://github.com/dealii/dealii/pull/15801

#15794: Use MGTransferGlobalCoarsening also for local smoothing (proposed by 
peterrum; merged) https://github.com/dealii/dealii/pull/15794

#15787: Require PETSc to be configured with MPI support (proposed by 
masterleinad; merged) https://github.com/dealii/dealii/pull/15787

#15785: PETScWrappers::TimeStepper support resizing while solving (proposed by 
stefanozampini; merged) https://github.com/dealii/dealii/pull/15785

#15649: Test serialization for serial and shared triangulations (proposed by 
pcafrica; merged) https://github.com/dealii/dealii/pull/15649

#14976: Add warning to pack_rtree_of_indices() (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/14976


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

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

#15847: Build Failure with PETSC-Complex, Invalid Static Cast (opened) 
https://github.com/dealii/dealii/issues/15847

#15846: Don't explicitly use FEValuesViews in 

[deal.II] deal.II Newsletter #262

2023-07-31 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

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

#15806: Add NodeVisitor in rtree.h (proposed by fdrmrc) 
https://github.com/dealii/dealii/pull/15806

#15805: Added gradient() evaluation to VectorFunctionFromTensorFunction 
(proposed by AbbBallout) https://github.com/dealii/dealii/pull/15805

#15803: NonMatching:  Add support for FE_Q_iso_Q1 to MeshClassifier and 
Discrete(Face)QuadratureGenerator (proposed by bergbauer) 
https://github.com/dealii/dealii/pull/15803

#15802: Adjust expectations in a GridTools::get_coarse_mesh_description(). 
(proposed by bangerth) https://github.com/dealii/dealii/pull/15802

#15801: Make GridGenerator::hyper_cube_with_cylindrical_hole<2>() more robust. 
(proposed by bangerth) https://github.com/dealii/dealii/pull/15801

#15800: AffineConstraints: fix warnings (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/15800

#15799: trilinos_sparse_matrix_mmult needs EpetraExt (proposed by masterleinad; 
merged) https://github.com/dealii/dealii/pull/15799

#15798: Fix block_vector_vector_assign (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/15798

#15797: DataOut::add_mg_data_vector(): copy vector and update ghost values 
(proposed by peterrum; merged) https://github.com/dealii/dealii/pull/15797

#15796: Simplify code using structured bindings. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/15796

#15795: Minor addition to the documentation of a GridTools function. (proposed 
by bangerth; merged) https://github.com/dealii/dealii/pull/15795

#15794: Use MGTransferGlobalCoarsening also for local smoothing (proposed by 
peterrum) https://github.com/dealii/dealii/pull/15794

#15793: `MGTransferMF::interpolate_to_mg()`: zero out ghost values (proposed by 
peterrum; merged) https://github.com/dealii/dealii/pull/15793

#15792: Add MGLevelObject::clear() (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/15792

#15791: Fix timing_step_37.cc (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/15791

#15789: Pre-compute what's needed for AffineConstraints::distribute(). 
(proposed by bangerth) https://github.com/dealii/dealii/pull/15789

#15788: [9.5] Allow compilation with PETSc but without MPI. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/15788

#15787: Require PETSc to be configured with MPI support (proposed by 
masterleinad) https://github.com/dealii/dealii/pull/15787

#15785: PETScWrappers::TimeStepper support resizing while solving (proposed by 
stefanozampini) https://github.com/dealii/dealii/pull/15785

#15784: Replace MGTransferMG usages in tests/matrix_free (proposed by peterrum; 
merged) https://github.com/dealii/dealii/pull/15784

#15783: More work to replace std::*::type by std::*_t. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/15783

#15782: MGLevelGlobalTransfer: remove unused variables (proposed by peterrum; 
merged) https://github.com/dealii/dealii/pull/15782

#15781: Allow compilation with PETSc but without MPI. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/15781

#15779: Small modifications to performance/timing_matrix_free_kokkos (proposed 
by peterrum; merged) https://github.com/dealii/dealii/pull/15779

#15777: CudaWrappers::MatrixFree: Only create required host mirrors (proposed 
by masterleinad; merged) https://github.com/dealii/dealii/pull/15777

#15776: Use MPILogInitAll in particles/generators_* tests (proposed by 
masterleinad; merged) https://github.com/dealii/dealii/pull/15776

#15775: CMake: only use REPEAT for >=3.15 (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/15775

#15773: Draft of FECouplingValues. (proposed by luca-heltai) 
https://github.com/dealii/dealii/pull/15773

#15772: Allow configuring with CMAKE_CXX_STANDARD=23 (proposed by masterleinad; 
merged) https://github.com/dealii/dealii/pull/15772

#15771: Add performance test for `CUDAWrapper::MatrixFree` (proposed by 
peterrum; merged) https://github.com/dealii/dealii/pull/15771

#15770: Config.h.in: use PETSc/SLEPc macros to determine PETSc/SLEPc version 
(proposed by stefanozampini; merged) https://github.com/dealii/dealii/pull/15770

#15769: Update PETScWrappers::NonlinearSolver (proposed by stefanozampini; 
merged) https://github.com/dealii/dealii/pull/15769

#15768: PETScWrappers: Support with-strict-petscerrorcode configurations 
(proposed by stefanozampini; merged) https://github.com/dealii/dealii/pull/15768

#15767: tweak PETSc tests (proposed by stefanozampini; merged) 
https://github.com/dealii/dealii/pull/15767

#15766: [C++17] Prefer std::is_*_v over std::is_*::value. (proposed by 

[deal.II] deal.II Newsletter #261

2023-07-14 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

#15746: [C++17] Prefer std::is_base_of_v over std::is_base_of::value. (proposed 
by bangerth) https://github.com/dealii/dealii/pull/15746

#15745: Small markup fixes. (proposed by bangerth) 
https://github.com/dealii/dealii/pull/15745

#15744: Add missing changelog entry about the improvement to step-68 (proposed 
by blaisb) https://github.com/dealii/dealii/pull/15744

#15743: Test mpi/petsc_step-27: fix race condition for output file (proposed by 
tamiko; merged) https://github.com/dealii/dealii/pull/15743

#15740: [C++17] Use std::is_floating_point_v instead of 
std::is_floating_point<...>::value. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/15740

#15739: [C++17] Use std::is_same_v instead of std::is_same<...>::value. 
(proposed by bangerth; merged) https://github.com/dealii/dealii/pull/15739

#15737: Copy Tpetra vector if we need to call "sync" (proposed by masterleinad; 
merged) https://github.com/dealii/dealii/pull/15737

#15736: Only warn about deprecated std_cxx17 headers for 
DEAL_II_EARLY_DEPRECATIONS (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/15736

#15735: Make VectorizedArray::sum() const (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/15735

#15734: README.md: update and rearrange badges (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/15734

#15731: Use "empty()" instead of "size() == 0" (proposed by masterleinad) 
https://github.com/dealii/dealii/pull/15731

#15730: Keep track of constraints we have already determined are finalized. 
(proposed by bangerth) https://github.com/dealii/dealii/pull/15730

#15729: MatrixFree: Memory consumption of mapping data faces by cells in 
MappingInfo (proposed by bergbauer; merged) 
https://github.com/dealii/dealii/pull/15729

#15727: Simplify a few places using cell->as_dof_handler_iterator(..). 
(proposed by simonsticko; merged) https://github.com/dealii/dealii/pull/15727

#15726: [9.5] bundled/tbb: fix compilation with gcc-13 (proposed by tamiko; 
merged) https://github.com/dealii/dealii/pull/15726

#15725: bundled/tbb: fix compilation with gcc-13 (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/15725

#15723: Don't use diff option (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/15723

#15722: README.md: reorganize badges in a nice row (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/15722

#15721: tests/examples/ fix script return value (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/15721

#15720: Add 1d support for ArborXWrappers (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/15720

#15719: Testsuite: let run_testsuite() print a summary (proposed by tamiko; 
merged) https://github.com/dealii/dealii/pull/15719

#15718: empty() function for Quadrature (proposed by bergbauer; merged) 
https://github.com/dealii/dealii/pull/15718

#15717: Timing step-68: Fix warnings + remove unnecessary mpi call (proposed by 
blaisb; merged) https://github.com/dealii/dealii/pull/15717

#15716: CMake: remove support for ctest_memcheck() and run_memorycheck.cmake 
(proposed by tamiko; merged) https://github.com/dealii/dealii/pull/15716

#15715: Re-add LinearAlgebra::set_zero_mean_value(). (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/15715

#15713: Some more small AffineConstraints code improvements. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/15713

#15711: Recommend NOX for building Trilinos. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/15711

#15709: Restrict tests requiring NOX (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/15709

#15708: [9.5] Guard NOX support in include/deal.II/numerics/nonlinear.h 
(proposed by masterleinad; merged) https://github.com/dealii/dealii/pull/15708

#15707: Triangulation::CellStatus: provide proper compatibility type (proposed 
by tamiko; merged) https://github.com/dealii/dealii/pull/15707

#15706: SolutionTransfer for (de)serializing serial triangulations (proposed by 
pcafrica) https://github.com/dealii/dealii/pull/15706

#15705: Use readability-qualified-auto clang-tidy check (proposed by 
masterleinad; merged) https://github.com/dealii/dealii/pull/15705

#15704: Guard NOX support in include/deal.II/numerics/nonlinear.h (proposed by 
masterleinad; merged) https://github.com/dealii/dealii/pull/15704

#15702: Fix doc typo (proposed by pcafrica; merged) 
https://github.com/dealii/dealii/pull/15702

#15700: Instantiate CellAttachedData and CellAttachedDataSerializer (proposed 
by peterrum; merged) https://github.com/dealii/dealii/pull/15700

#15699: Address more unnecessary calls to .c_str(). (proposed by bangerth; 

[deal.II] deal.II Newsletter #260

2023-07-07 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

#15679: Use parallel::apply_to_subranges(). (proposed by bangerth) 
https://github.com/dealii/dealii/pull/15679

#15678: Fix face orientation (proposed by peterrum) 
https://github.com/dealii/dealii/pull/15678

#15677: KINSOL: allow for custom setup (proposed by sebproell) 
https://github.com/dealii/dealii/pull/15677

#15675: Test examples/step-40: avoid std::cout race condition (proposed by 
tamiko; merged) https://github.com/dealii/dealii/pull/15675

#15674: documentation: switch all hyperlinks in the documentation to https:// 
(proposed by tamiko; merged) https://github.com/dealii/dealii/pull/15674

#15673: matrix_free/fe_evaluation.h: avoid a warning with g++-13 (proposed by 
tamiko; merged) https://github.com/dealii/dealii/pull/15673

#15672: Introduce DEAL_II[_DEPRECATED_EARLY]_WITH_COMMENT (proposed by 
masterleinad; merged) https://github.com/dealii/dealii/pull/15672

#15671: Avoid const return type in functions (proposed by masterleinad) 
https://github.com/dealii/dealii/pull/15671

#15670: Tests: update official tester names (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/15670

#15669: [9.5] Use -Werror again in enable_if_supported (proposed by tamiko; 
merged) https://github.com/dealii/dealii/pull/15669

#15668: Remove reference to VectorSpacevector from the documentation. (proposed 
by bangerth; merged) https://github.com/dealii/dealii/pull/15668

#15667: Remove reference to VectorSpaceVector from ReadWriteVector's 
documentation. (proposed by bangerth) 
https://github.com/dealii/dealii/pull/15667

#15666: Remove derivation of LinearAlgebra::distributed::Vector from 
VectorSpaceVector. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/15666

#15665: Update minimum compiler versions for C++17 (proposed by masterleinad; 
merged) https://github.com/dealii/dealii/pull/15665

#15664: Add a missing typedef to the epetra vector wrapper. (proposed by 
drwells; merged) https://github.com/dealii/dealii/pull/15664

#15661: clang-tidy: Enable readability-container-size-empty check (proposed by 
masterleinad) https://github.com/dealii/dealii/pull/15661

#15660: Fix some comparisons operator for g++-13 with C++20 (proposed by 
masterleinad; merged) https://github.com/dealii/dealii/pull/15660

#15658: Add missing include path for `ReadVector` (proposed by mschreter; 
merged) https://github.com/dealii/dealii/pull/15658

#15657: Fix step-46 tutorial program (proposed by kronbichler; merged) 
https://github.com/dealii/dealii/pull/15657

#15656: Tests: grid/mesh_3d.h: add forgotten GridTests::reorder* call (proposed 
by tamiko; merged) https://github.com/dealii/dealii/pull/15656

#15655: github: update indent worker to Ubuntu 22.04 (proposed by tamiko) 
https://github.com/dealii/dealii/pull/15655

#15654: Tests: add forgotten namespace, fix typo in includes (proposed by 
tamiko; merged) https://github.com/dealii/dealii/pull/15654

#15653: enable examples/ tests in quick tests (proposed by tamiko) 
https://github.com/dealii/dealii/pull/15653

#15652: github: update linux runners (proposed by tamiko) 
https://github.com/dealii/dealii/pull/15652

#15651: Tests: if no numdiff executable is found fall back to running tests 
instead of dropping them (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/15651

#15649: Test serialization for serial and shared triangulations (proposed by 
pcafrica) https://github.com/dealii/dealii/pull/15649

#15645: Change step-68 + timing_step-68 to use FEPointEvaluator (proposed by 
blaisb; merged) https://github.com/dealii/dealii/pull/15645

#15644: Quick tests: also run examples/ tests (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/15644

#15642: Test fe/fe_enriched_step-36: make a test less expensive (proposed by 
tamiko; merged) https://github.com/dealii/dealii/pull/15642

#15641: Fix some more clang-tidy findings (proposed by masterleinad) 
https://github.com/dealii/dealii/pull/15641

#15640: Use balanced braces for doxygen formulas. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/15640

#15639: Remove a funny exit path in AffineConstraints::close(). (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/15639

#15637: Create a vector space vector concept. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/15637

#15636: base/exceptions.h: avoid warnings in Trilinos / Kokkos headers 
(proposed by tamiko; merged) https://github.com/dealii/dealii/pull/15636

#15635: FEEvaluation: Use n_lanes class variable (proposed by bergbauer; 
merged) https://github.com/dealii/dealii/pull/15635

#15634: Taskflow for async (proposed by tjhei) 
https://github.com/dealii/dealii/pull/15634

#15633: Get rid of VectorSpaceVector in the 

[deal.II] deal.II Newsletter #259

2023-06-30 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

#15539: Remove deprecated LegacySignal. (proposed by marcfehling) 
https://github.com/dealii/dealii/pull/15539

#15538: Use ArborX for spatial search in `guess_owners_of_entities()` (proposed 
by fdrmrc) https://github.com/dealii/dealii/pull/15538

#15537: MatrixFree: Reduce header inclusions in expensive factory files 
(proposed by kronbichler) https://github.com/dealii/dealii/pull/15537

#15536: Simplify IndexSet::add_index() (proposed by kronbichler) 
https://github.com/dealii/dealii/pull/15536

#15535: Avoid one potential quadratic complexity case in IndexSet::add_ranges 
(proposed by kronbichler) https://github.com/dealii/dealii/pull/15535

#15534: Remove deprecated Vector member functions (proposed by masterleinad) 
https://github.com/dealii/dealii/pull/15534

#15533: [9.5] Only enable -ffp-exception-behavior=strict for some platforms. 
(proposed by tamiko; merged) https://github.com/dealii/dealii/pull/15533

#15532: Only enable -ffp-exception-behavior=strict for some platforms. 
(proposed by drwells; merged) https://github.com/dealii/dealii/pull/15532

#15530: Remove deprecated functions in fe_interface_values.h (proposed by 
masterleinad) https://github.com/dealii/dealii/pull/15530

#15529: Remove deprecations in consensus algorithms (proposed by masterleinad) 
https://github.com/dealii/dealii/pull/15529

#15528: Remove deprecated CellDataTransferBuffer (proposed by masterleinad) 
https://github.com/dealii/dealii/pull/15528

#15527: FEFaceEvaluation: Fix ECL for continuous elements (proposed by 
bergbauer) https://github.com/dealii/dealii/pull/15527

#15526: CMake: fix submit_results.cmake (proposed by tamiko) 
https://github.com/dealii/dealii/pull/15526

#15525: Do not remove duplicates before inserting index set elements. (proposed 
by bangerth; merged) https://github.com/dealii/dealii/pull/15525

#15524: Test: mpi/locally_owned_dofs_per_subdomain_02: do not compare output 
(proposed by tamiko; merged) https://github.com/dealii/dealii/pull/15524

#15523: [9.5] Test: mpi/locally_owned_dofs_per_subdomain_02: do not compare 
output (proposed by tamiko; merged) https://github.com/dealii/dealii/pull/15523

#15521: Make output of non_nested_transfer tests less verbose (proposed by 
fdrmrc) https://github.com/dealii/dealii/pull/15521

#15520: Shorten compilation time of two MatrixFree tests (proposed by 
kronbichler) https://github.com/dealii/dealii/pull/15520

#15518: [9.5] CMake: remove taskflow macros from config.h.in (proposed by 
tamiko; merged) https://github.com/dealii/dealii/pull/15518

#15517: Fix MGTwoLevelTransfer when used without MPI (proposed by kronbichler; 
merged) https://github.com/dealii/dealii/pull/15517

#15516: Move job_supports_mpi() to a more central place (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/15516

#15515: [9.5] CMake: remove VTK configure option (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/15515

#15514: [9.5] Fix output for matrix_free/matrix_free_device_initialize_vector 
with CUDA support (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/15514

#15513: Fix output for matrix_free/matrix_free_device_initialize_vector with 
CUDA support (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/15513

#15511: [9.5] Remove taskflow configuration option and bundled library 
(proposed by tamiko; merged) https://github.com/dealii/dealii/pull/15511

#15510: [9.5] CMake: enable -ffp-exceptions-behavior=strict when compiling with 
clang (proposed by tamiko; merged) https://github.com/dealii/dealii/pull/15510

#15509: CMake: enable -ffp-exceptions-behavior=strict when compiling with clang 
(proposed by tamiko; merged) https://github.com/dealii/dealii/pull/15509

#15508: Post release branch: require the current version of deal.II (proposed 
by tamiko; merged) https://github.com/dealii/dealii/pull/15508

#15507: Post release branch: switch DEAL_II_DEPRECATED_EARLY over to 
DEAL_II_DEPRECATED (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/15507

#15506: [9.5] update AUTHORS.md and LICENSE.md (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/15506

#15505: Post release branch: update VERSION on main branch (proposed by tamiko; 
merged) https://github.com/dealii/dealii/pull/15505

#15503: Update the changelog file for the release. (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/15503

#15502: Fix compiling with clang-16 and C++20 (proposed by masterleinad; 
merged) https://github.com/dealii/dealii/pull/15502

#15500: Tests: exonerate two debug test variants and run them again (proposed 
by tamiko; merged) https://github.com/dealii/dealii/pull/15500

#15499: CMake: run_test.sh: ensure to never bind to cores/processors 

[deal.II] deal.II Newsletter #258

2023-06-23 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

#15455: add mailmap entry (proposed by tamiko) 
https://github.com/dealii/dealii/pull/15455

#15454: Advertise NonlinearSolverSelector in step-77. (proposed by bangerth) 
https://github.com/dealii/dealii/pull/15454

#15452: Fix invalid data access in MatrixFreeTools::compute_diagonal (proposed 
by kronbichler; merged) https://github.com/dealii/dealii/pull/15452

#15451: Fix invalid memory access of DoFAccessorImplementation (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/15451

#15450: NOX: catch std::runtime_error instead of char* for Trilinos 4.2.0 
onwards (proposed by tamiko) https://github.com/dealii/dealii/pull/15450

#15449: Test numerics/nonlinear_solver_selector_03: use 
check_solver_within_range macro (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/15449

#15448: Test cgal/cgal_surface_mesh_02: disable floating point exceptions 
(proposed by tamiko; merged) https://github.com/dealii/dealii/pull/15448

#15447: Test base/hdf5_0{3,5}.mpirun={1,4}: do not compare test output 
(proposed by tamiko; merged) https://github.com/dealii/dealii/pull/15447

#15446: lac/parpack_solver: add missing compress() operation (proposed by 
tamiko; merged) https://github.com/dealii/dealii/pull/15446

#15445: TriaIterator: return a proper Accessor temporary (proposed by tamiko) 
https://github.com/dealii/dealii/pull/15445

#15444: matrix_free/tools.h: avoid stack use after scope (proposed by tamiko) 
https://github.com/dealii/dealii/pull/15444

#15443: [Post-9.5] Add an assertion. (proposed by bangerth) 
https://github.com/dealii/dealii/pull/15443

#15442: fix step-57 bilinear form (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/15442

#15441: MFTools::categorize_by_boundary_ids: use iterator (proposed by 
peterrum; merged) https://github.com/dealii/dealii/pull/15441

#15438: [Post-9.5] Simplify some code that uses SolutionTransfer. (proposed by 
bangerth) https://github.com/dealii/dealii/pull/15438

#15437: Fix step-33. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/15437

#15436: Warn about the use of higher order output when using Visit. (proposed 
by bangerth; merged) https://github.com/dealii/dealii/pull/15436

#15435: Add a better error message for Cuda + bundled Kokkos. (proposed by 
drwells; merged) https://github.com/dealii/dealii/pull/15435

#15434: Examples 9.5 (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/15434

#15431: Fix bug in AffineConstraints::make_sorted_row_list (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/15431

#15430: Fix bug in MatrixFree setup for FE_Nothing (proposed by kronbichler; 
merged) https://github.com/dealii/dealii/pull/15430

#15429: CGAL: fix some bogus warnings with gcc-13 (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/15429

#15428: fe/fe_values: avoid a "maybe uninitialized" warning with gcc-13 
(proposed by tamiko; merged) https://github.com/dealii/dealii/pull/15428

#15425: CMake: avoid adding ${DEAL_II_BUNDLED_INCLUDE_DIRS} to bundled targets 
(proposed by tamiko; merged) https://github.com/dealii/dealii/pull/15425

#15423: Fix a few more 'set up' (proposed by kronbichler; merged) 
https://github.com/dealii/dealii/pull/15423

#15422: Fix clang-tidy complaints (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/15422

#15420: [Post-9.5] Add a version of step-67 that uses PETSc TS time stepping. 
(proposed by bangerth) https://github.com/dealii/dealii/pull/15420

#15419: [Post-9.5] Minor adjustment to versions of step-77 in the test suite. 
(proposed by bangerth) https://github.com/dealii/dealii/pull/15419

#15418: [Post-9.5] When we know that sparsity pattern entries are sorted, 
communicate that. (proposed by bangerth) 
https://github.com/dealii/dealii/pull/15418

#15417: [Post-9.5] Standardize on the idiom of calling std::erase after 
std::unique. (proposed by bangerth) https://github.com/dealii/dealii/pull/15417

#15416: [Post-9.5] Rename a lambda function and make it easier to read. 
(proposed by bangerth) https://github.com/dealii/dealii/pull/15416

#15415: FE_Hermite objects for solving with Hermite finite elements (proposed 
by ivweber) https://github.com/dealii/dealii/pull/15415

#15414: Fix doxygen reflinks (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/15414

#15413: Move source/matrix_free up in build order (proposed by kronbichler; 
merged) https://github.com/dealii/dealii/pull/15413

#15412: Spell 'set up' when used as a verb (proposed by kronbichler; merged) 
https://github.com/dealii/dealii/pull/15412

#15411: Testsuite: symengine/symengine_tensor_operations_04: fix test 
compilation (proposed by tamiko; merged) 

[deal.II] deal.II Newsletter #257

2023-06-10 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

#15339: Minor adjustments to FETools::extrapolate(). (proposed by bangerth) 
https://github.com/dealii/dealii/pull/15339

#15338: Clarify the name of a variable. (proposed by bangerth) 
https://github.com/dealii/dealii/pull/15338

#15336: FEPointEvaluation with FEDG_Q and n_components >1  (proposed by 
jh66637) https://github.com/dealii/dealii/pull/15336

#15335: Fix a typo in step-8 (proposed by Rombur; merged) 
https://github.com/dealii/dealii/pull/15335

#15334: ensure distribute_local_to_global() is called with contiguous iterators 
(proposed by jh66637; merged) https://github.com/dealii/dealii/pull/15334

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

#15330: Adjust iterator traits classes for C++20. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/15330

#15329: Add something about postprocessing to step-4. (proposed by bangerth) 
https://github.com/dealii/dealii/pull/15329

#15328: Use ReferenceCell::closest_point() in 
GridTools::find_active_cell_around_point(). (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/15328

#15327: github-actions: Do not treat `tautological-constant-compare` as error. 
(proposed by marcfehling) https://github.com/dealii/dealii/pull/15327

#15326: Fix compiler warning with clang-16 (proposed by kronbichler; merged) 
https://github.com/dealii/dealii/pull/15326

#15325: Fix compiling with Trilinos 14 and Cuda (proposed by masterleinad; 
merged) https://github.com/dealii/dealii/pull/15325

#15324: Remove unused mpi_communicator pointer members initialized by 
temporaries (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/15324

#15323: `TriaAccessor`: remove outdated assert for `n_faces()` for 
`structdim!=dim` (proposed by mschreter) 
https://github.com/dealii/dealii/pull/15323

#15322: Prefer numbers::is_nan over std::isnan (proposed by marcfehling; 
merged) https://github.com/dealii/dealii/pull/15322

#15321: Only install new Intel compilers. (proposed by marcfehling; merged) 
https://github.com/dealii/dealii/pull/15321

#15319: Add utility function returning point indices which are not found 
(proposed by jh66637) https://github.com/dealii/dealii/pull/15319

#15318: Make distribute_local_to_global() work with std:: iterators (proposed 
by jh66637; merged) https://github.com/dealii/dealii/pull/15318

#15317: Minor updates to step-62. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/15317

#15316: Minor updates to step-69. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/15316

#15315: Mark loop indices as 'const' where possible. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/15315

#15314: Use numbers::is_finite whenever we compare with infinity. (proposed by 
marcfehling; merged) https://github.com/dealii/dealii/pull/15314

#15313: Be systematic in how we name arguments of FEValues member functions. 
(proposed by bangerth; merged) https://github.com/dealii/dealii/pull/15313

#15312: Hotfix muparser: Fix problem with IntelLLVM finite math (proposed by 
marcfehling; merged) https://github.com/dealii/dealii/pull/15312

#15311: Fix a comment at the end of an ifdef. (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/15311

#15308: Test icpx instead of icpc (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/15308

#15307: Fix dim = 1 mesh loading with gmsh. (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/15307

#15306: Use one process to build with Intel to decrease memory usage. (proposed 
by marcfehling) https://github.com/dealii/dealii/pull/15306

#15304: use FEPE::get_normal_vector() to be consistent with FEE (proposed by 
jh66637; merged) https://github.com/dealii/dealii/pull/15304

#15303: Tensor product evaluation at arbitrary points: Optimize linear case 
(proposed by kronbichler) https://github.com/dealii/dealii/pull/15303

#15300: Fix matrix_free test. (proposed by marcfehling; merged) 
https://github.com/dealii/dealii/pull/15300

#15299: Avoid taking references on temporaries. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/15299

#15297: Choose to initialize BlockVector with ghost elements using 
reinit(partitioners). (proposed by marcfehling) 
https://github.com/dealii/dealii/pull/15297

#15296: Mark two tests as dependent on p4est. (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/15296

#15295: Unify multiple copies of the same function. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/15295

#15292: Add flag to NM::MappingInfo reinit functions (proposed by jh66637; 
merged) https://github.com/dealii/dealii/pull/15292

#15283: Use Kokkos 

[deal.II] deal.II Newsletter #256

2023-06-02 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

#15295: Unify multiple copies of the same function. (proposed by bangerth) 
https://github.com/dealii/dealii/pull/15295

#15294: Document that compute_aspect_ratio_of_cells() requires LAPACK. 
(proposed by drwells; merged) https://github.com/dealii/dealii/pull/15294

#15293: Wrap some PETSc documentation lines. (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/15293

#15292: Add flag to NM::MappingInfo reinit functions (proposed by jh66637) 
https://github.com/dealii/dealii/pull/15292

#15291: Add changelog entry. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/15291

#15290: Add CITATIONS.bib file to suggest citation in GitHub (proposed by 
masterleinad; merged) https://github.com/dealii/dealii/pull/15290

#15289: TensorProductMatrixSymmetricSum: small modifications (proposed by 
peterrum; merged) https://github.com/dealii/dealii/pull/15289

#15288: MGTwoLevelTransfer: Clean old vector content in prolongate_add 
(proposed by kronbichler; merged) https://github.com/dealii/dealii/pull/15288

#15287: MappingFEField: Remove update_JxW_values for Piola transform (proposed 
by bergbauer; merged) https://github.com/dealii/dealii/pull/15287

#15286: Deprecate our own CUDA backend (proposed by Rombur) 
https://github.com/dealii/dealii/pull/15286

#15285: Fix GitHub Linux CI (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/15285

#15284: Use distinct names for PETSC call_and_possibly_capture_exception 
functions (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/15284

#15283: Use Kokkos CMake targets (proposed by masterleinad) 
https://github.com/dealii/dealii/pull/15283

#15282: Fix a couple clang-tidy warnings (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/15282

#15281: FEPointEvaluation: Integrate should use JxW (proposed by bergbauer; 
merged) https://github.com/dealii/dealii/pull/15281

#15278: Use dealii-dependencies Docker for GitHub workflow (proposed by 
pcafrica; merged) https://github.com/dealii/dealii/pull/15278

#15277: Fix data format in some changelogs. (proposed by marcfehling; merged) 
https://github.com/dealii/dealii/pull/15277

#15276: recoverable SNES and TS (proposed by stefanozampini) 
https://github.com/dealii/dealii/pull/15276

#15275: Fix some matrix_free tests without vectorization (proposed by 
masterleinad; merged) https://github.com/dealii/dealii/pull/15275

#15274: FEPointEvaluation: skip renumbering when possible (proposed by 
bergbauer; merged) https://github.com/dealii/dealii/pull/15274

#15273: Tensor product kernels: Evaluate integrate values only (proposed by 
bergbauer; merged) https://github.com/dealii/dealii/pull/15273

#15271: Convert PETSc SNES interfaces to use callback error conventions. 
(proposed by bangerth; merged) https://github.com/dealii/dealii/pull/15271

#15270: Fix warnings when compiling with nvcc_wrapper (proposed by Rombur; 
merged) https://github.com/dealii/dealii/pull/15270

#15269: Make the PETSc TS interfaces conform to callback conventions. (proposed 
by bangerth; merged) https://github.com/dealii/dealii/pull/15269

#15267: Add 'requires' clauses for matrix template arguments to PETSc TS and 
SNES solvers. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/15267

#15264: Suppress 'requires' clauses for doxygen if doxygen is too old. 
(proposed by bangerth; merged) https://github.com/dealii/dealii/pull/15264

#15263: Convert IDA to use the callback standard. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/15263

#15262: Test CUDAWrappers::MatrixFree not only for DEAL_II_WITH_CUDA (proposed 
by masterleinad; merged) https://github.com/dealii/dealii/pull/15262

#15261: remove inexact CGAL kernels and add test (proposed by jh66637; merged) 
https://github.com/dealii/dealii/pull/15261

#15217: Make MatrixFree evaluation kernels more flexible w.r.t. number type 
(proposed by kronbichler; merged) https://github.com/dealii/dealii/pull/15217

#15209: Integrate DG into non-nested MG (proposed by jh66637; merged) 
https://github.com/dealii/dealii/pull/15209

#15165: Introduce DistributedComputeIntersectionLocationsInternal (proposed by 
jh66637; merged) https://github.com/dealii/dealii/pull/15165

#14569: Tensor product matrix collection fix vectorization (proposed by 
peterrum; merged) https://github.com/dealii/dealii/pull/14569

#14536: Choose to initialize ghost elements with reinit(partitioner). (proposed 
by marcfehling; merged) https://github.com/dealii/dealii/pull/14536

#14346: Add process_dofs_vectorized_transpose() variants with constant_offset 
(proposed by peterrum; merged) https://github.com/dealii/dealii/pull/14346

#14327: Precompute inverse diagonal (FDM) (proposed by 

[deal.II] deal.II Newsletter #255

2023-05-25 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

#15269: Make the PETSc TS interfaces conform to callback conventions. (proposed 
by bangerth) https://github.com/dealii/dealii/pull/15269

#15268: Identity constraints in h-adapted grids? (proposed by marcfehling) 
https://github.com/dealii/dealii/pull/15268

#15267: Add 'requires' clauses for matrix template arguments to PETSc TS and 
SNES solvers. (proposed by bangerth) https://github.com/dealii/dealii/pull/15267

#15266: Added support for VTK (proposed by pcafrica) 
https://github.com/dealii/dealii/pull/15266

#15265: Fix TpetraWrappers::Vector import (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/15265

#15264: Suppress 'requires' clauses for doxygen if doxygen is too old. 
(proposed by bangerth) https://github.com/dealii/dealii/pull/15264

#15263: Convert IDA to use the callback standard. (proposed by bangerth) 
https://github.com/dealii/dealii/pull/15263

#15262: Test CUDAWrappers::MatrixFree not only for DEAL_II_WITH_CUDA (proposed 
by masterleinad) https://github.com/dealii/dealii/pull/15262

#15261: remove inexact CGAL kernels and add test (proposed by jh66637) 
https://github.com/dealii/dealii/pull/15261

#15258: step-14 tutorial: Fix typo in introduction (proposed by kronbichler; 
merged) https://github.com/dealii/dealii/pull/15258

#15257: CMake: also escape linker flags of the form -Wl,-rpath -Wl,/path/ 
(proposed by tamiko; merged) https://github.com/dealii/dealii/pull/15257

#15256: CMake: use import targets for configuring Trilinos (proposed by tamiko) 
https://github.com/dealii/dealii/pull/15256

#15255: Simplify a function declaration. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/15255

#15254: CMake: Use import targets in FindDEAL_II_BOOST.cmake (proposed by 
tamiko) https://github.com/dealii/dealii/pull/15254

#15253: CMake: multiple fixes for check_compiler_setup() (proposed by tamiko; 
merged) https://github.com/dealii/dealii/pull/15253

#15252: CMake: introduce copy_target_properties() macro (proposed by tamiko; 
merged) https://github.com/dealii/dealii/pull/15252

#15251: CMake: small updates to process_feature() and preparatory cleanup 
(proposed by tamiko) https://github.com/dealii/dealii/pull/15251

#15250: Cleanup CUDAWrappers::MatrixFree (proposed by Rombur; merged) 
https://github.com/dealii/dealii/pull/15250

#15249: CMake: add TARGET keywords to process_feature() macro (proposed by 
tamiko) https://github.com/dealii/dealii/pull/15249

#15247: Minor updates to the ARKode documentation. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/15247

#15245: Avoid making a variable 'public' in the ARKode interfaces. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/15245

#15244: Add an idea regarding precision to step-15. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/15244

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

#15242: More interface mismatch in ScratchData in hp mode. (proposed by 
marcfehling; merged) https://github.com/dealii/dealii/pull/15242

#15241: Fix compilation with ARKODE. (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/15241

#15240: Horizontal add function for VectorizedArray (proposed by bergbauer; 
merged) https://github.com/dealii/dealii/pull/15240

#15238: Initialize and check an assertion in the NOX solver. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/15238

#15235: Fix Tpetra for newer Trilinos (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/15235

#15233: fix bug in find_active_cell_around_point (proposed by richardschu; 
merged) https://github.com/dealii/dealii/pull/15233

#15229: MatrixFree: Avoid setting face vectorization group boundary in serial 
(proposed by kronbichler; merged) https://github.com/dealii/dealii/pull/15229

#15223: Convert ARKode interfaces to conform to our callback policy. (proposed 
by bangerth; merged) https://github.com/dealii/dealii/pull/15223

#15200: Use Kokkos to launch kernels in CUDAWrappers::MatrixFree  (proposed by 
Rombur; merged) https://github.com/dealii/dealii/pull/15200

#15195: Avoid the name 'import' as a function name. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/15195


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

#15260: SCALAPACK symbol check for pdsyevr_ and pssyevr_ failed (opened) 
https://github.com/dealii/dealii/issues/15260

#15259: Modernize step-14 (opened) https://github.com/dealii/dealii/issues/15259

#15248: Getter function RemotePointEvaluation::get_points_not_found()? (opened) 
https://github.com/dealii/dealii/issues/15248

#15246: Remove duplication of call_and_possibly_capture_exception(). 

[deal.II] deal.II Newsletter #254

2023-05-18 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

#15239: Fix the number of pyramid lines and one pyramid table. (proposed by 
drwells) https://github.com/dealii/dealii/pull/15239

#15238: Initialize and check an assertion in the NOX solver. (proposed by 
bangerth) https://github.com/dealii/dealii/pull/15238

#15237: Properly treat exceptions in a user callback in NOX. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/15237

#15236: Minor updates to the NOX solver documentation. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/15236

#15235: Fix Tpetra for newer Trilinos (proposed by masterleinad) 
https://github.com/dealii/dealii/pull/15235

#15233: fix bug in find_active_cell_around_point (proposed by richardschu) 
https://github.com/dealii/dealii/pull/15233

#15231: improve documentation for PETSc SNES (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/15231

#15230: Patterns: Fix parsing lists of lists (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/15230

#15229: MatrixFree: Avoid setting face vectorization group boundary in serial 
(proposed by kronbichler) https://github.com/dealii/dealii/pull/15229

#15228: Avoid compiler warning (proposed by kronbichler; merged) 
https://github.com/dealii/dealii/pull/15228

#15226: Tpetra is not functional without sync() function (proposed by 
sebproell) https://github.com/dealii/dealii/pull/15226

#15223: Convert ARKode interfaces to conform to our callback policy. (proposed 
by bangerth) https://github.com/dealii/dealii/pull/15223

#15222: Minor doc improvement in step-6. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/15222

#15221: Update output of step-77. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/15221

#15220: fix some compiler warnings (proposed by richardschu; merged) 
https://github.com/dealii/dealii/pull/15220

#15219: fixed some compiler warnings in tria.cc (proposed by richardschu) 
https://github.com/dealii/dealii/pull/15219

#15218: Add a function for computing distances to unit cells. (proposed by 
drwells) https://github.com/dealii/dealii/pull/15218

#15217: Make MatrixFree evaluation kernels more flexible w.r.t. number type 
(proposed by kronbichler) https://github.com/dealii/dealii/pull/15217

#15216: SUNDIALS: remove outdated copy functionality (proposed by sebproell; 
merged) https://github.com/dealii/dealii/pull/15216

#15215: Face path for FEPointEvaluation (proposed by bergbauer; merged) 
https://github.com/dealii/dealii/pull/15215

#15214: Fix step-77 NOX test (proposed by sebproell; merged) 
https://github.com/dealii/dealii/pull/15214

#15212: Fix Kokkos compilation with GCC 13. (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/15212

#15211: FEPointEvaluation: Use template argument consistently (proposed by 
bergbauer; merged) https://github.com/dealii/dealii/pull/15211

#15210: Fix step-77: zero out residual before assembly (proposed by sebproell; 
merged) https://github.com/dealii/dealii/pull/15210

#15209: Integrate DG into non-nested MG (proposed by jh66637) 
https://github.com/dealii/dealii/pull/15209

#15208: Fix typo in documentation (proposed by kronbichler; merged) 
https://github.com/dealii/dealii/pull/15208

#15207: Tensor product kernels: Use the right type in some templated functions 
(proposed by kronbichler; merged) https://github.com/dealii/dealii/pull/15207

#15206: Fix warnings with gcc-13.1 (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/15206

#15205: CMake: create a compile_commands.json symlink (proposed by tamiko; 
merged) https://github.com/dealii/dealii/pull/15205

#15204: Adds create_with_same_size function (proposed by MarcelKoch) 
https://github.com/dealii/dealii/pull/15204

#15203: Updates Ginkgo solver wrappers (proposed by MarcelKoch) 
https://github.com/dealii/dealii/pull/15203

#15202: Adds wrappers for Ginkgo matrices (proposed by MarcelKoch) 
https://github.com/dealii/dealii/pull/15202

#15200: Use Kokkos to launch kernels in CUDAWrappers::MatrixFree  (proposed by 
Rombur) https://github.com/dealii/dealii/pull/15200

#15199: Allow finding user-installed HDF5 (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/15199

#15197: Add an abstract base class ReadVector purely for vector access. 
(proposed by drwells) https://github.com/dealii/dealii/pull/15197

#15196: Avoid variables named 'import', part 2. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/15196

#15195: [WIP] Avoid the name 'import' as a function name. (proposed by 
bangerth) https://github.com/dealii/dealii/pull/15195

#15194: KINSOL: do not copy vectors internally (proposed by sebproell; merged) 
https://github.com/dealii/dealii/pull/15194

#15193: 

[deal.II] deal.II Newsletter #253

2023-05-11 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

#15193: Remove overhead from AlignedVector in FEFaceNormalEvaluationImpl 
(proposed by bergbauer) https://github.com/dealii/dealii/pull/15193

#15192: Fix compilation of a test. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/15192

#15191: Avoid variables named 'import'. (proposed by bangerth) 
https://github.com/dealii/dealii/pull/15191

#15190: Adding wrappers for Ginkgo vectors (proposed by MarcelKoch) 
https://github.com/dealii/dealii/pull/15190

#15189: Add a test with an irrecoverable failure of KINSOL. (proposed by 
bangerth) https://github.com/dealii/dealii/pull/15189

#15188: Clean up after ourselves. (proposed by bangerth) 
https://github.com/dealii/dealii/pull/15188

#15187: Catch and rethrow *all* exceptions. (proposed by bangerth) 
https://github.com/dealii/dealii/pull/15187

#15186: Let NOX callbacks conform to our new standard for callback errors. 
(proposed by bangerth) https://github.com/dealii/dealii/pull/15186

#15185: Weight kernel for multigrid: Simplify aliasing analysis for compiler 
(proposed by kronbichler; merged) https://github.com/dealii/dealii/pull/15185

#15184: Add a ScopeExit class. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/15184

#15183: Reduce operation count in polynomial evaluation (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/15183

#15182: Reduce overhead in calls to tensor product value function (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/15182

#15181: Avoid missing symbols and use constexpr functions instead (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/15181

#15180: More NOX tests (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/15180

#15179: Fix up the single NOX test (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/15179

#15178: Let KINSOL callbacks conform to our new standard for callback errors. 
(proposed by bangerth; merged) https://github.com/dealii/dealii/pull/15178

#15177: Make some variables in a few tests 'const'. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/15177

#15176: Fix do_reinit of FEPointEvaluation for empty unit_points (proposed by 
bergbauer; merged) https://github.com/dealii/dealii/pull/15176

#15173: Add the PETSc SNES version of step-77 as a test. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/15173

#15171: Let doxygen resolve a citation in step-77. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/15171

#15169: Move a function out of line. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/15169

#15159: pass MPI_Comm by value (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/15159

#15154: make it possible to fill RPE with 
GT::DistributedComputePointLocation... (proposed by jh66637; merged) 
https://github.com/dealii/dealii/pull/15154

#15144: Clarify the documentation of a reinit() function. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/15144

#15141: Add two level transfer operator between non-nested levels (proposed by 
fdrmrc; merged) https://github.com/dealii/dealii/pull/15141

#15138: Implement alternative rules what quadrature/mapping object to use in 
FEInterfaceValues::reinit(). (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/15138

#15132: Add 'requires' clauses to PETSc solvers. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/15132

#15128: In step-77, also talk about the other nonlinear solver packages we 
support. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/15128


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

#15096: Develop more tiebreakers for FEInterfaceValues::reinit() for different 
kinds of elements. (closed) https://github.com/dealii/dealii/issues/15096


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 

[deal.II] deal.II Newsletter #252

2023-05-04 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

#15177: Make some variables in a few tests 'const'. (proposed by bangerth) 
https://github.com/dealii/dealii/pull/15177

#15176: Fix do_reinit of FEPointEvaluation for empty unit_points (proposed by 
bergbauer) https://github.com/dealii/dealii/pull/15176

#15175: Don't try to find deal.II quietly in the examples (proposed by 
masterleinad; merged) https://github.com/dealii/dealii/pull/15175

#15173: Add the PETSc SNES version of step-77 as a test. (proposed by bangerth) 
https://github.com/dealii/dealii/pull/15173

#15172: Add a test to check KINSOL's ability to deal with recoverable errors. 
(proposed by bangerth; merged) https://github.com/dealii/dealii/pull/15172

#15171: Let doxygen resolve a citation in step-77. (proposed by bangerth) 
https://github.com/dealii/dealii/pull/15171

#15170: Do not reference a deprecated function. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/15170

#15169: Move a function out of line. (proposed by bangerth) 
https://github.com/dealii/dealii/pull/15169

#15167: Avoid empty quad in MappingInfo::reinit_cells() (proposed by fdrmrc; 
merged) https://github.com/dealii/dealii/pull/15167

#15166: introduce distributed_compute_intersection_locations (proposed by 
jh66637) https://github.com/dealii/dealii/pull/15166

#15165: Introduce DistributedComputeIntersectionLocationsInternal (proposed by 
jh66637) https://github.com/dealii/dealii/pull/15165

#15164: Allow using Trilinos 14.0 (proposed by masterleinad) 
https://github.com/dealii/dealii/pull/15164

#15163: RPE::evaluate_and_process(): pack only if needed (proposed by peterrum) 
https://github.com/dealii/dealii/pull/15163

#15161: Update documentation about CUDA requirements (proposed by masterleinad; 
merged) https://github.com/dealii/dealii/pull/15161

#15160: NonlinearSolverSelector class implementation (proposed by singima) 
https://github.com/dealii/dealii/pull/15160

#15159: pass MPI_Comm by value (proposed by tjhei) 
https://github.com/dealii/dealii/pull/15159

#15158: MGTwoLevelTransfer: use ConstraintInfo also for fine vectors (proposed 
by peterrum; merged) https://github.com/dealii/dealii/pull/15158

#15156: Refactor RPE::evaluate_and_process() (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/15156

#15155: Fix bug in integrate_add_tensor_product_value_and_gradient_linear() for 
1d (proposed by bergbauer; merged) https://github.com/dealii/dealii/pull/15155

#15154: make it possible to fill RPE with 
GT::DistributedComputePointLocation... (proposed by jh66637) 
https://github.com/dealii/dealii/pull/15154

#15153: Format journals in bibliography. (proposed by marcfehling; merged) 
https://github.com/dealii/dealii/pull/15153

#15152: Format authors in bibliography. (proposed by marcfehling; merged) 
https://github.com/dealii/dealii/pull/15152

#15151: Allow MappingInfo::reinit_cells() to work on containers (proposed by 
fdrmrc; merged) https://github.com/dealii/dealii/pull/15151

#15150: Add getter for cell_data in RPE (proposed by fdrmrc; merged) 
https://github.com/dealii/dealii/pull/15150

#15149: Introduce `MGTwoLevelTransferBase` (proposed by fdrmrc; merged) 
https://github.com/dealii/dealii/pull/15149

#15147: MatrixFree diagonal: Avoid repeated computations and binary search 
(proposed by kronbichler; merged) https://github.com/dealii/dealii/pull/15147

#15146: Document how we deal with errors in call-backs. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/15146

#15137: Vectorize NonMatching::MappingInfo (proposed by bergbauer; merged) 
https://github.com/dealii/dealii/pull/15137

#15134: Make it possible to document C++20 requirements (and do so). (proposed 
by bangerth; merged) https://github.com/dealii/dealii/pull/15134

#15121: CMake: Test link interface again (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/15121


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

#15174: Improve error message when deal.II found but not the right version. 
(opened and closed) https://github.com/dealii/dealii/issues/15174

#15168: Future direction of the diffent Vector classes in deal.II (opened) 
https://github.com/dealii/dealii/issues/15168

#15162: MatrixFree: Unify `DoFInfo` and `ConstraintInfo` (opened) 
https://github.com/dealii/dealii/issues/15162

#15157: Question about patch for GINKGO cmake method (opened) 
https://github.com/dealii/dealii/issues/15157

#15077: vanilla Ubuntu 20.04 linker errors with OpenMPI (closed) 
https://github.com/dealii/dealii/issues/15077


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, 

[deal.II] deal.II Newsletter #251

2023-04-27 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

#15151: Allow MappingInfo::reinit_cells() to work on containers (proposed by 
fdrmrc) https://github.com/dealii/dealii/pull/15151

#15150: Add getter for cell_data in RPE (proposed by fdrmrc) 
https://github.com/dealii/dealii/pull/15150

#15149: Introduce `MGTwoLevelTransferBase` (proposed by fdrmrc) 
https://github.com/dealii/dealii/pull/15149

#15147: MatrixFree diagonal: Avoid repeated computations and binary search 
(proposed by kronbichler) https://github.com/dealii/dealii/pull/15147

#15146: Document how we deal with errors in call-backs. (proposed by bangerth) 
https://github.com/dealii/dealii/pull/15146

#15145: Various changes to bibliography. (proposed by marcfehling; merged) 
https://github.com/dealii/dealii/pull/15145

#15144: Clarify the documentation of a reinit() function. (proposed by 
bangerth) https://github.com/dealii/dealii/pull/15144

#15143: Update bibtex entries of preprints. (proposed by marcfehling; merged) 
https://github.com/dealii/dealii/pull/15143

#15142: Convert step-57 references to bibtex, with proper cross-referencing. 
(proposed by bangerth; merged) https://github.com/dealii/dealii/pull/15142

#15141: Add two level transfer operator between non-nested levels (proposed by 
fdrmrc) https://github.com/dealii/dealii/pull/15141

#15140: Auto merge scalar components of `DataOut_DoFData` into vectors and 
tensors (proposed by vovannikov) https://github.com/dealii/dealii/pull/15140

#15139: Add necessary include files to a code snippet in the glossary. 
(proposed by bangerth; merged) https://github.com/dealii/dealii/pull/15139

#15138: Implement alternative rules what quadrature/mapping object to use in 
FEInterfaceValues::reinit(). (proposed by bangerth) 
https://github.com/dealii/dealii/pull/15138

#15137: Vectorize NonMatching::MappingInfo (proposed by bergbauer) 
https://github.com/dealii/dealii/pull/15137

#15136: Remove commented assert (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/15136

#15135: MatrixFree diagonal: Avoid quadratic complexity & memory allocations 
(proposed by kronbichler; merged) https://github.com/dealii/dealii/pull/15135

#15134: Make it possible to document C++20 requirements (and do so). (proposed 
by bangerth) https://github.com/dealii/dealii/pull/15134

#15133: Add changelog entry for SNES and TS (proposed by stefanozampini; 
merged) https://github.com/dealii/dealii/pull/15133

#15132: Add 'requires' clauses to PETSc solvers. (proposed by bangerth) 
https://github.com/dealii/dealii/pull/15132

#15131: More doxygen fixes. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/15131

#15130: Added changelog for #14866. (proposed by marcfehling; merged) 
https://github.com/dealii/dealii/pull/15130

#15129: A variety of doxygen fixes. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/15129

#15128: In step-77, also talk about the other nonlinear solver packages we 
support. (proposed by bangerth) https://github.com/dealii/dealii/pull/15128

#15127: Sort terms so that the bilinear form has ...phi_i * phi_j ... in 
step-57. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/15127

#15126: PETScWrappers::TimeStepper fix backward compatibility to 3.7 (proposed 
by stefanozampini; merged) https://github.com/dealii/dealii/pull/15126

#15125: Remove tabulated shape functions from MappingQ (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/15125

#15124: Implement arbitrary order derivatives for tensor-product evaluators 
(proposed by kronbichler; merged) https://github.com/dealii/dealii/pull/15124

#15122: ParameterAcceptor now uses a set. (proposed by luca-heltai; merged) 
https://github.com/dealii/dealii/pull/15122

#15121: CMake: Test link interface again (proposed by masterleinad) 
https://github.com/dealii/dealii/pull/15121

#15120: Add an example to the documentation of GridTools::transform(). 
(proposed by bangerth; merged) https://github.com/dealii/dealii/pull/15120

#15119: Update PETSc compatibility stuff for SNES and TS (proposed by 
stefanozampini; merged) https://github.com/dealii/dealii/pull/15119

#15118: PETScWrappers: update KSP support (proposed by stefanozampini; merged) 
https://github.com/dealii/dealii/pull/15118

#15079: More gracefully deal with Windoze line endings. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/15079

#15065: PETScWrappers: Add support for nonlinear solver (proposed by 
stefanozampini; merged) https://github.com/dealii/dealii/pull/15065

#15051: Return objects by value, rather than via a reference. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/15051

#14969: Add a move assignment operator to LA::d::V. (proposed by drwells; 
merged) 

[deal.II] deal.II Newsletter #250

2023-04-20 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

#15118: PETScWrappers: update KSP support (proposed by stefanozampini) 
https://github.com/dealii/dealii/pull/15118

#15117: PETScWrappers Fix docs for SF classes (proposed by stefanozampini) 
https://github.com/dealii/dealii/pull/15117

#15116: block fixes (proposed by stefanozampini) 
https://github.com/dealii/dealii/pull/15116

#15115: Fix a class name in step-69 commentary. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/15115

#15113: Address the pesky 'MPI_Comm as void*' problem with the SUNDIALS 
interfaces (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/15113

#15109: Remove PETSc compatibility things. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/15109

#15108: Fix heading level in step-7 results.dox. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/15108

#15107: Fix a funny comment. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/15107

#15106: Add 'requires' clauses to the rest of the triangulation classes. 
(proposed by bangerth; merged) https://github.com/dealii/dealii/pull/15106

#15105: Fix interface mismatch in ScratchData in hp mode. (proposed by 
marcfehling; merged) https://github.com/dealii/dealii/pull/15105

#15104: Improve error message. (proposed by marcfehling; merged) 
https://github.com/dealii/dealii/pull/15104

#15103: Add a test for FEInterfaceValues::reinit with no dominating FE. 
(proposed by marcfehling; merged) https://github.com/dealii/dealii/pull/15103

#15102: Add tolerance to box in compute_point_locations_try_all (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/15102

#15101: extend distributed_compute_point_locations (proposed by jh66637; 
merged) https://github.com/dealii/dealii/pull/15101

#15100: Better document an argument to hp::FEFaceValues. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/15100

#15099: Add a check and produce better errors in FEInterfaceValues::reinit(). 
(proposed by bangerth; merged) https://github.com/dealii/dealii/pull/15099

#15098: Better document ExcFunctionNonzeroReturn exception. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/15098

#15097: Better document FEInterfaceValues::reinit(). (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/15097

#15093: examples/step-1: undo accidental changes to CMakeLists.txt (proposed by 
tamiko; merged) https://github.com/dealii/dealii/pull/15093

#15092: Use latest ubuntu image in docker.yml. (proposed by marcfehling; 
merged) https://github.com/dealii/dealii/pull/15092

#15091: Convert PreconditionChebyshev::set_initial_guess_kernel to Kokkos 
(proposed by masterleinad; merged) https://github.com/dealii/dealii/pull/15091

#15088: Don't mention wrong defaults in CompressionFlags (proposed by 
sebproell; merged) https://github.com/dealii/dealii/pull/15088

#15083: Fix some minor typos (proposed by olegrog; merged) 
https://github.com/dealii/dealii/pull/15083

#15074: Build both focal and jammy images. (proposed by luca-heltai; merged) 
https://github.com/dealii/dealii/pull/15074

#15066: PETScWrappers: Add support for ODE solver (proposed by stefanozampini; 
merged) https://github.com/dealii/dealii/pull/15066

#15035: Optimize mapping computation in MappingQ (proposed by bergbauer; 
merged) https://github.com/dealii/dealii/pull/15035

#15033: Add signed distance function for Zalesak's disk (proposed by mschreter; 
merged) https://github.com/dealii/dealii/pull/15033

#15013: Enable vectorization over quadrature points in whole FEPointEvaluation 
(proposed by bergbauer; merged) https://github.com/dealii/dealii/pull/15013

#14988: Rework the introduction to step-7. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/14988

#14987: Leave a hint in step-7. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/14987


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

#15114: step-69 does not mark momentum as a vector for DataOut (opened) 
https://github.com/dealii/dealii/issues/15114

#15112: Do not return error codes via int return values in external interfaces 
(opened) https://github.com/dealii/dealii/issues/15112

#15111: ParameterAcceptor::clear() leads to use after free (opened) 
https://github.com/dealii/dealii/issues/15111

#15110: ParameterHandler::add_parameter() doesn't work with unsigned int 
variable defaulted to invalid_unsigned_int (opened) 
https://github.com/dealii/dealii/issues/15110

#15096: Develop more tiebreakers for FEInterfaceValues::reinit() for different 
kinds of elements. (opened) https://github.com/dealii/dealii/issues/15096

#15095: Force user to provide q_index in FEInterfaceValues::reinit() if the two 

[deal.II] deal.II Newsletter #249

2023-04-12 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

#15087: Allow template argument deduction in ndarray (proposed by masterleinad) 
https://github.com/dealii/dealii/pull/15087

#15086: All get_mpi_communicator methods now return MPI_Comm by value (proposed 
by stefanozampini) https://github.com/dealii/dealii/pull/15086

#15084: Map boundary to bulk dof iterators. (proposed by luca-heltai) 
https://github.com/dealii/dealii/pull/15084

#15083: Fix some minor typos (proposed by olegrog) 
https://github.com/dealii/dealii/pull/15083

#15082: Minor updates to the NOX solver interfaces. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/15082

#15081: Avoid using include with quotation marks (proposed by masterleinad; 
merged) https://github.com/dealii/dealii/pull/15081

#15079: More gracefully deal with Windoze line endings. (proposed by bangerth) 
https://github.com/dealii/dealii/pull/15079

#15078: Fix some minor typos (proposed by olegrog) 
https://github.com/dealii/dealii/pull/15078

#15075: Avoid use of MPI_COMM_WORLD (proposed by kronbichler; merged) 
https://github.com/dealii/dealii/pull/15075

#15074: Build both focal and jammy images. (proposed by luca-heltai) 
https://github.com/dealii/dealii/pull/15074

#15072: Minor updates to the ndarray documentation. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/15072

#15071: Do not infringe on the compiler's use of names. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/15071

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

#15067: Stefanozampini/tutorials (proposed by stefanozampini) 
https://github.com/dealii/dealii/pull/15067

#15066: PETScWrappers: Add support for ODE solver (proposed by stefanozampini) 
https://github.com/dealii/dealii/pull/15066

#15065: PETScWrappers: Add support for nonlinear solver (proposed by 
stefanozampini) https://github.com/dealii/dealii/pull/15065

#15064: some more info about SLEPc-PETSc misaligned versions (proposed by 
stefanozampini; merged) https://github.com/dealii/dealii/pull/15064

#15063: Improve support for MATNEST (proposed by stefanozampini; merged) 
https://github.com/dealii/dealii/pull/15063

#15062: Remove write_tecplot_binary and related code (proposed by masterleinad; 
merged) https://github.com/dealii/dealii/pull/15062

#15060: Remove docker image with root user. (proposed by marcfehling; merged) 
https://github.com/dealii/dealii/pull/15060

#15059: Optimize FlatManifold::get_new_points (proposed by kronbichler; merged) 
https://github.com/dealii/dealii/pull/15059

#15058: Improve code in QProjector in terms of performance and simplicity 
(proposed by kronbichler; merged) https://github.com/dealii/dealii/pull/15058

#15057: Initialize Quadrature with move argument (proposed by kronbichler; 
merged) https://github.com/dealii/dealii/pull/15057

#15056: PETSc nonlinear solver and ODE integrator (proposed by stefanozampini) 
https://github.com/dealii/dealii/pull/15056

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

#15054: Fix a missing bracket in step-34 intro (proposed by simonsticko; 
merged) https://github.com/dealii/dealii/pull/15054

#15053: Fix a typo. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/15053

#15052: Fix malformed @return statements. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/15052

#15051: Return objects by value, rather than via a reference. (proposed by 
bangerth) https://github.com/dealii/dealii/pull/15051

#15050: Optimize insertion of elements into a matrix. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/15050

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

#15047: Clarifications in commentary in various places. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/15047

#15046: Add entries to an IndexSet in already-sorted order. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/15046

#15043: Rename a few variables to make their intent clearer. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/15043

#15042: Update documentation in IndexSet for a couple of functions. (proposed 
by bangerth; merged) https://github.com/dealii/dealii/pull/15042

#15041: Don't overallocate memory. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/15041

#15040: Simplify code slightly. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/15040

#15039: More tests (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/15039

#15038: Fix FEDomination in FEInterfaceValues and ScratchData. (proposed by 
marcfehling) 

[deal.II] deal.II Newsletter #248

2023-04-04 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

#15024: Make FEPointEval expose same types as FEEval (proposed by jh66637; 
merged) https://github.com/dealii/dealii/pull/15024

#15023: instantiate mapped quadrature for dim=1 and spacedim=2 (proposed by 
jh66637; merged) https://github.com/dealii/dealii/pull/15023

#15022: Address some compile time issues. (proposed by bangerth) 
https://github.com/dealii/dealii/pull/15022

#15019: Increment the majorest version number. (proposed by drwells) 
https://github.com/dealii/dealii/pull/15019

#15015: FEPointEvaluation: disconnect from MappingInfo (proposed by peterrum; 
merged) https://github.com/dealii/dealii/pull/15015

#15014: Clean up notions of CUDA in the codebase (proposed by masterleinad; 
merged) https://github.com/dealii/dealii/pull/15014

#15013: Enable vectorization over quadrature points in whole FEPointEvaluation 
(proposed by bergbauer) https://github.com/dealii/dealii/pull/15013

#15012: FEPointEvaluation::integrate: Choose better loop layout (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/15012

#15011: Work around nvcc compiler bug in 
mg_transfer_global_coarsening.templates.h (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/15011

#15010: Introduce helper Utilities::callable_member (proposed by sebproell) 
https://github.com/dealii/dealii/pull/15010

#15009: Check whether construct_multigrid_hierarchy is set ealier. (proposed by 
adamqc) https://github.com/dealii/dealii/pull/15009

#15008: Add Functions::SignedDistance::Rectangle (proposed by mschreter) 
https://github.com/dealii/dealii/pull/15008

#15007: Fix copy constructor of MappingQ (proposed by peterrum) 
https://github.com/dealii/dealii/pull/15007

#15006: CMake: fix variable name (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/15006

#15005: Add a test for GridTools::Cache::get_covering_rtree(). (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/15005

#15004: Minor doc updates in GridTools. (proposed by bangerth) 
https://github.com/dealii/dealii/pull/15004

#15003: Use Kokkos for data structures in CUDA matrix-free framework (proposed 
by Rombur) https://github.com/dealii/dealii/pull/15003

#15002: Fix a unused variable compiler warning in tria.cc (proposed by 
masterleinad; merged) https://github.com/dealii/dealii/pull/15002

#15001: OSX tester does not pick up /rebuild (proposed by marcfehling; merged) 
https://github.com/dealii/dealii/pull/15001

#15000: Update SUNDIALS link in doc/readme.html (proposed by masterleinad; 
merged) https://github.com/dealii/dealii/pull/15000

#14999: Fix nodal and Gauss-type quadratures for dim = 0. (proposed by drwells; 
merged) https://github.com/dealii/dealii/pull/14999

#14998: CMake: refactor repetitive option handling into two macros (proposed by 
tamiko; merged) https://github.com/dealii/dealii/pull/14998

#14997: Explain the purpose of some computations in CellIDTranslator. (proposed 
by bangerth; merged) https://github.com/dealii/dealii/pull/14997

#14995: MatrixFreeTools: fix some refs and const (proposed by sebproell; 
merged) https://github.com/dealii/dealii/pull/14995

#14993: CMake: Rename DEAL_II_NAMESPACE to DEAL_II_TARGET_NAME (proposed by 
tamiko; merged) https://github.com/dealii/dealii/pull/14993

#14992: CMake: prefer CMAKE_CXX_STANDARD and export cxx_std_?? COMPILE_FEATURES 
target property (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/14992

#14991: CMake: use POSITION_INDEPENDENT_CODE target property instead of setting 
-fPIC by hand (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/14991

#14990: CMake: separate warning flags into DEAL_II_WARNING_FLAGS variable 
(proposed by tamiko; merged) https://github.com/dealii/dealii/pull/14990

#14989: Fix FEPointEvaluation for different n_q_points with same MappingInfo 
for different evaluators (proposed by bergbauer; merged) 
https://github.com/dealii/dealii/pull/14989

#14988: Rework the introduction to step-7. (proposed by bangerth) 
https://github.com/dealii/dealii/pull/14988

#14987: Leave a hint in step-7. (proposed by bangerth) 
https://github.com/dealii/dealii/pull/14987

#14986: Step-70: remove unused variable (proposed by mschreter; merged) 
https://github.com/dealii/dealii/pull/14986

#14983: Change default `compression_level` of vtu output (proposed by 
c-p-schmidt) https://github.com/dealii/dealii/pull/14983

#14982: Compute values_of_array only once and optimize instructions (proposed 
by bergbauer; merged) https://github.com/dealii/dealii/pull/14982

#14981: Add benchmark for multgrid with global coarsening (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/14981

#14971: Create dealii::dealii target and add compile options (proposed by 

[deal.II] deal.II Newsletter #247

2023-03-28 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

#14982: Compute values_of_array only once and optimize instructions (proposed 
by bergbauer) https://github.com/dealii/dealii/pull/14982

#14981: Add benchmark for multgrid with global coarsening (proposed by 
kronbichler) https://github.com/dealii/dealii/pull/14981

#14978: Move OrthogonalizationStrategy into new file (proposed by peterrum) 
https://github.com/dealii/dealii/pull/14978

#14977: Do not expose internal details of BoundingBox. (proposed by bangerth) 
https://github.com/dealii/dealii/pull/14977

#14976: Add warning to pack_rtree_of_indices() (proposed by peterrum) 
https://github.com/dealii/dealii/pull/14976

#14975: Use functionality from ReferenceCell in QProjector. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/14975

#14974: Add new functions to BoundingBox (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/14974

#14973: Add to the documentation of a function in GridTools. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/14973

#14972: Template loop bounds for flexible evaluate/integrate function (proposed 
by bergbauer; merged) https://github.com/dealii/dealii/pull/14972

#14971: Create dealii::dealii target and add compile options (proposed by 
masterleinad) https://github.com/dealii/dealii/pull/14971

#14970: Be more correct in our noexcept usage. (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/14970

#14969: Add a move assignment operator to LA::d::V. (proposed by drwells) 
https://github.com/dealii/dealii/pull/14969

#14967: Use ConstraintLine rather than redefining data structures (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/14967

#14966: Step-70: fix typo (proposed by mschreter; merged) 
https://github.com/dealii/dealii/pull/14966

#14964: Deprecate type 'identity'. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/14964

#14963: Remove dealii:: prefix from VectorOperation. (proposed by drwells; 
merged) https://github.com/dealii/dealii/pull/14963

#14962: CMake: do not use PUBLIC keyword for target_link_libraries for tests 
(proposed by tamiko; merged) https://github.com/dealii/dealii/pull/14962

#14961: CMake: avoid a warning in the check_compiler_setup macro (proposed by 
tamiko; merged) https://github.com/dealii/dealii/pull/14961

#14960: Remove the LINK_LANGUAGE:CXX generator. (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/14960

#14959: Introduce FEEvaluationImplSelector (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/14959

#14958: Enable output of compressed hdf5 files (proposed by c-p-schmidt) 
https://github.com/dealii/dealii/pull/14958

#14957: Fix typo in TaskInfo (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/14957

#14956: Add missing (?) inline (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/14956

#14955: [WIP] Remove specialization of 
CellwiseInverseMassMatrixImplBasic::run() (proposed by peterrum) 
https://github.com/dealii/dealii/pull/14955

#14954: cmake fix (proposed by jh66637) 
https://github.com/dealii/dealii/pull/14954

#14953: Work on ShapeInfo::is_supported() (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/14953

#14952: Fix a test regarding concepts. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/14952

#14951: Fix a couple of C++20 concepts in parallel.h. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/14951

#14950: Use std_cxx20::type_identity_t instead of identity<...>::type. 
(proposed by bangerth; merged) https://github.com/dealii/dealii/pull/14950

#14948: Refactor `internal::guess_point_owner` (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/14948

#14946: Fix a C++20 cmake check. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/14946

#14945: Add missing explicit template instantiations for 
compute_affine_transformation (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/14945

#14944: make_flux_sparsity_pattern() continuing revision (proposed by vyushut) 
https://github.com/dealii/dealii/pull/14944

#14943: FEEvaluation: fix docs for fast_evaluation_supported() (proposed by 
sebproell; merged) https://github.com/dealii/dealii/pull/14943

#14942: Clean up some extra 'dealii::'s. (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/14942

#14940: Fix .prm file in step-60 (proposed by fdrmrc; merged) 
https://github.com/dealii/dealii/pull/14940

#14939: Fix linkage when complex values are disabled. (proposed by drwells; 
merged) https://github.com/dealii/dealii/pull/14939

#14938: [C++20] Apply concepts to thread_management.h. (proposed by bangerth; 
merged) 

[deal.II] deal.II Newsletter #246

2023-03-21 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

#14929: TrilinosWrappers::PreconditionBase deprecate AdditionalData and minor 
cleanup (proposed by sebproell) https://github.com/dealii/dealii/pull/14929

#14928: Add an empty() function to ArrayView (proposed by bergbauer) 
https://github.com/dealii/dealii/pull/14928

#14927: Introduce quadrature_points_indices() function for FEPointEvaluation 
(proposed by bergbauer) https://github.com/dealii/dealii/pull/14927

#14926: FEPointEvaluation: Remove unit_points member, access them through 
MappingInfo instead (proposed by bergbauer) 
https://github.com/dealii/dealii/pull/14926

#14924: Fix namespacing in the ExodusII error macro. (proposed by drwells; 
merged) https://github.com/dealii/dealii/pull/14924

#14923: Remove obsolete CMake test for `MPI_SEEK_SET` (proposed by sloede; 
merged) https://github.com/dealii/dealii/pull/14923

#14921: Use  header for C++20 feature checks (proposed by 
masterleinad; merged) https://github.com/dealii/dealii/pull/14921

#14920: Move check about FECollection size to DoFHandler. (proposed by 
marcfehling) https://github.com/dealii/dealii/pull/14920

#14919: Simplify Trilinos solver's AdditionalData (proposed by sebproell; 
merged) https://github.com/dealii/dealii/pull/14919

#14918: [C++17] Use std::array instead of a C-style array. (proposed by 
bangerth) https://github.com/dealii/dealii/pull/14918

#14917: Update documentation of Quadrature. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/14917

#14916: Update description of UpdateFlags::update_quadrature_points. (proposed 
by bangerth; merged) https://github.com/dealii/dealii/pull/14916

#14915: Add a compatibility type for C++20's std::type_identity. (proposed by 
bangerth) https://github.com/dealii/dealii/pull/14915

#14914: Remove dummy changelog entry (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/14914

#14913: SolverFGMRES: refactor orthogonalization (proposed by peterrum) 
https://github.com/dealii/dealii/pull/14913

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

#14911: Fix a grammar mistake. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/14911

#14910: Make it more obvious that evaluation points are not quadrature points. 
(proposed by bangerth; merged) https://github.com/dealii/dealii/pull/14910

#14909: Update documentation for DataPostprocessor. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/14909

#14908: Do not ask for things we don't actually need. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/14908

#14907: Add test to ensure consistent constraints in parallel (proposed by 
kronbichler) https://github.com/dealii/dealii/pull/14907

#14906: Add a link to the documentation. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/14906

#14905: Add consistent strategy to merge constraints in parallel (proposed by 
bergbauer) https://github.com/dealii/dealii/pull/14905

#14904: Add instantiation to for off-diagonal contributions to DiagonalMatrix 
(proposed by bergbauer; merged) https://github.com/dealii/dealii/pull/14904

#14903: Select correct code path for neighbor elements in FEEvaluation 
(proposed by bergbauer; merged) https://github.com/dealii/dealii/pull/14903

#14902: Jenkins: enable and update arm MacOS build (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/14902

#14901: Remove DoFInfo::dimension (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/14901

#14900: Different documentation updates in `matrix_free` (proposed by peterrum; 
merged) https://github.com/dealii/dealii/pull/14900

#14899: Do not allow assigning to rvalue references of Tensor. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/14899

#14898: Limit friend declarations for DofHandler and Triangulation to the same 
template arguments (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/14898

#14897: Fix concepts support for TpetraWrappers::Vector (proposed by 
masterleinad; merged) https://github.com/dealii/dealii/pull/14897

#14896: Doxygen: fix missing related link in ArrayView (proposed by sebproell; 
merged) https://github.com/dealii/dealii/pull/14896

#14895: Fix concepts support for clang++ (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/14895

#14894: FEEvaluation: use EvaluationFlags in documentation (proposed by 
peterrum; merged) https://github.com/dealii/dealii/pull/14894

#14892: Use VectorizedArrayTrait (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/14892

#14890: CellWiseInverse: extend comments (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/14890

#14889: Clean up 

[deal.II] deal.II Newsletter #245

2023-03-14 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

#14886: improve docu of VectorTools::interpolate_boundary_values() (proposed by 
nfehn) https://github.com/dealii/dealii/pull/14886

#14885: Explicit Instantiate GridTools::collect_periodic_faces with Meshtype = 
parallel::shared::triangulation<1,1> (proposed by nils-schween) 
https://github.com/dealii/dealii/pull/14885

#14884: Allow external initialization of MPI and p4est (proposed by sloede) 
https://github.com/dealii/dealii/pull/14884

#14883: clean up a test (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/14883

#14882: [C++20] Annotate 'MeshType' template parameters with concepts (proposed 
by bangerth) https://github.com/dealii/dealii/pull/14882

#14881: Reduce header inclusions (proposed by kronbichler; merged) 
https://github.com/dealii/dealii/pull/14881

#14880: Mark more functions used in Assert as DEAL_II_HOST_DEVICE (proposed by 
masterleinad; merged) https://github.com/dealii/dealii/pull/14880

#14878: Redo some indexing inside FESystem. (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/14878

#14877: Partial revert of #14753 (proposed by Rombur) 
https://github.com/dealii/dealii/pull/14877

#14876: Minor improvement to an error message. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/14876

#14875: Minor improvement to an error message about an unsupported case. 
(proposed by bangerth; merged) https://github.com/dealii/dealii/pull/14875

#14874: Replace #if DEBUG with #ifdef DEBUG (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/14874

#14869: Initialize Kokkos with MultithreadInfo::n_threads() (proposed by 
masterleinad; merged) https://github.com/dealii/dealii/pull/14869

#14868: make_flux_sparsity_pattern() revision (proposed by vyushut; merged) 
https://github.com/dealii/dealii/pull/14868

#14866: Warn users about FE index mismatch instead of silently dropping them. 
(proposed by marcfehling) https://github.com/dealii/dealii/pull/14866

#14865: Expose eigenvectors of LAPACKFullMatrix (proposed by kronbichler) 
https://github.com/dealii/dealii/pull/14865

#14863: Fix a missing transpose. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/14863

#14862: step-69: Use commonly used name for time step number. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/14862

#14861: Use better variable names in step-69. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/14861

#14860: Make an input variable in step-69 'const'. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/14860

#14857: Simplify an exception definition (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/14857

#14856: [C++20] Annotate the VectorTools functions with vector concepts. 
(proposed by bangerth; merged) https://github.com/dealii/dealii/pull/14856

#14855: Fix a mistaken 'requires' annotation. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/14855

#14853: Simplify a ?: expression in step-22. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/14853

#14852: Clarify documentation. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/14852

#14851: Rename a variable in step-69 to make its purpose clearer. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/14851

#14809: NonMatching::MappingInfo: precompute mapping data for an IteratorRange 
of cells/faces (proposed by bergbauer; merged) 
https://github.com/dealii/dealii/pull/14809

#14691: Fix vertex numbering from deal to UCD (proposed by nlsmrg; merged) 
https://github.com/dealii/dealii/pull/14691

#14605: Classical Gram-Schmidt for block vectors (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/14605

#14562: ParameterHandler::add_parameter(): do not call action (proposed by 
peterrum; merged) https://github.com/dealii/dealii/pull/14562

#14360: Get vertices in CGAL order on face (proposed by jh66637; merged) 
https://github.com/dealii/dealii/pull/14360


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

#14879: GridTools::collect_periodic_faces with parallel:shared::Triangulation 
in 1D (opened) https://github.com/dealii/dealii/issues/14879

#14873: Doxygen site: forced dark mode has bright white table of contents in 
Firefox (opened) https://github.com/dealii/dealii/issues/14873

#14872: Question: batched FE_Values reinit? (opened and closed) 
https://github.com/dealii/dealii/issues/14872

#14871: Docu of VectorTools::interpolate_boundary_values() unclear (opened) 
https://github.com/dealii/dealii/issues/14871

#14870: Deallii / Trilinos interaction (opened and closed) 
https://github.com/dealii/dealii/issues/14870

#14867: External Kokkos with openmp 

[deal.II] deal.II Newsletter #244

2023-03-07 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

#14850: Implement InverseCellwiseMassMatrix with tensor var. coeff. (proposed 
by btemuer) https://github.com/dealii/dealii/pull/14850

#14849: Speed-up icpc CI (proposed by masterleinad) 
https://github.com/dealii/dealii/pull/14849

#14848: CI: print full compiler command line (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/14848

#14847: Print detailed.log instead of archiving it (proposed by masterleinad; 
merged) https://github.com/dealii/dealii/pull/14847

#14846: make_array_view overload for AlignedVector (proposed by sebproell; 
merged) https://github.com/dealii/dealii/pull/14846

#14845: Extract link line from CI (proposed by tamiko) 
https://github.com/dealii/dealii/pull/14845

#14842: Do not allow assigning to rvalue references of VectorizedArray. 
(proposed by bangerth; merged) https://github.com/dealii/dealii/pull/14842

#14839: SymmetricTensor access returns const reference (proposed by sebproell; 
merged) https://github.com/dealii/dealii/pull/14839

#14838: Fix SymmetricTensor::deviator for VectorizedArray (proposed by 
sebproell; merged) https://github.com/dealii/dealii/pull/14838

#14837: Move AdditionalData outside of class definition (proposed by sebproell) 
https://github.com/dealii/dealii/pull/14837

#14836: Play with C++20 concepts (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/14836

#14829: Make Mapping::get_center() work with simplices. (proposed by drwells; 
merged) https://github.com/dealii/dealii/pull/14829

#14806: enable compressed debug info for library (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/14806

#14751: Fix compiling for the Kokkos CUDA backend using clang (proposed by 
masterleinad; merged) https://github.com/dealii/dealii/pull/14751

#14727: Get mapped vertices of face (proposed by jh66637; merged) 
https://github.com/dealii/dealii/pull/14727


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

#14844: Step-70 runtime error (opened) 
https://github.com/dealii/dealii/issues/14844

#14843: Adding tensor-valued variable coefficients to matrix-free 
CellwiseInverseMassMatrix (opened) https://github.com/dealii/dealii/issues/14843

#14841: active_dof_index out of range gives no exception when FECollection has 
size 1 (opened) https://github.com/dealii/dealii/issues/14841

#14840: Add C++20-style concepts to deal.II classes and functions (opened) 
https://github.com/dealii/dealii/issues/14840

#14749: building with Clang 15.0.7 and cuda support (closed) 
https://github.com/dealii/dealii/issues/14749


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/64076da9.050a0220.b1964.c4e3SMTPIN_ADDED_MISSING%40gmr-mx.google.com.


[deal.II] deal.II Newsletter #243

2023-02-28 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

#14835:  Fix bug in result of SolverCG when run in interleaved mode (proposed 
by kronbichler) https://github.com/dealii/dealii/pull/14835

#14834: Fix an array index warning. (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/14834

#14833: Fix grammar in an error message. (proposed by simonsticko; merged) 
https://github.com/dealii/dealii/pull/14833

#14832: Avoid some more instantiations of class Triangulation for invalid 
arguments. (proposed by bangerth) https://github.com/dealii/dealii/pull/14832

#14831: Produce .inst files that are easier to read. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/14831

#14830: Define what the "lumped mass matrix is". (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/14830

#14829: Make Mapping::get_center() work with simplices. (proposed by drwells) 
https://github.com/dealii/dealii/pull/14829

#14828: Don't derive InvalidAccessor from TriaAccessorBase. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/14828

#14827: Fix an 'unused typedef' warning. (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/14827

#14826: Define mass and stiffness matrix in the glossary. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/14826

#14825: step-82: rename output filename (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/14825

#14824: Only instantiate TpetraWrappers::Vector for types that have explicit 
instantiations in Tpetra (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/14824

#14823: FEPointEvaluation: fix typo (proposed by mschreter; merged) 
https://github.com/dealii/dealii/pull/14823

#14822: Fix bug in MappingQCache(1) with cell similarity (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/14822

#14821: Fix NVCC CI (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/14821

#14820: simplex doxygen: more cleanup (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/14820

#14819: fix comment location (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/14819

#14818: step-2: Make program more useful. (proposed by bangerth) 
https://github.com/dealii/dealii/pull/14818

#14817: step-2: Clarify some text. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/14817

#14816: step-2: Separate number from main file name. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/14816

#14813: implement VectorTools::add_constant (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/14813

#14803: Include bundled include directories as CMake SYSTEM paths (proposed by 
masterleinad; merged) https://github.com/dealii/dealii/pull/14803

#14794: doxygen: simplex relates (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/14794

#14784: Implement ReferenceCell::face_vertex_location(). (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/14784

#14783: Suppress some nvcc warnings (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/14783

#14772: Use Kokkos::abort directly (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/14772

#14758: Fix compiling with Trilinos+Sacado+Cuda (proposed by masterleinad; 
merged) https://github.com/dealii/dealii/pull/14758


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

#14815: Docker image has issues linking with Trilinos (opened and closed) 
https://github.com/dealii/dealii/issues/14815

#14814: TPetra usable check issues (opened) 
https://github.com/dealii/dealii/issues/14814

#14487: Compilation errors in Trilinos with Cuda support (closed) 
https://github.com/dealii/dealii/issues/14487


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/63fe3332.050a0220.407b3.f9e0SMTPIN_ADDED_MISSING%40gmr-mx.google.com.


[deal.II] deal.II Newsletter #242

2023-02-20 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

#14813: implement VectorTools::add_constant (proposed by tjhei) 
https://github.com/dealii/dealii/pull/14813

#14811: Fix Tpetra detection and unit tests (proposed by masterleinad) 
https://github.com/dealii/dealii/pull/14811

#14810: Fix using mesh_loop with DG and periodic boundary conditions (proposed 
by masterleinad; merged) https://github.com/dealii/dealii/pull/14810

#14809: NonMatching::MappingInfo: precompute mapping data for an IteratorRange 
of cells/faces (proposed by bergbauer) 
https://github.com/dealii/dealii/pull/14809

#14808: CI: Jenkins increase timeout (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/14808

#14806: enable compressed debug info for library (proposed by tjhei) 
https://github.com/dealii/dealii/pull/14806

#14805: fix unused variable warning (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/14805

#14803: Include bundled include directories as CMake SYSTEM paths (proposed by 
masterleinad) https://github.com/dealii/dealii/pull/14803

#14802: FieldTransfer: enable coarsening (proposed by sebproell; merged) 
https://github.com/dealii/dealii/pull/14802

#14801: Fix description of assemble_system() in step-40. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/14801

#14800: Fix a grammar mistake. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/14800

#14798: disable -Wdeprecated-builtins for boost (proposed by tjhei) 
https://github.com/dealii/dealii/pull/14798

#14797: fix wrong sign of char in MF (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/14797

#14796: remove useless comment (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/14796

#14793: doc: replace FE_DGRT with correct name (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/14793

#14792: doc: move simplex function from module (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/14792

#14790: doc: fix GridGenerator::convert_hypercube_to_simplex_mesh (proposed by 
tjhei; merged) https://github.com/dealii/dealii/pull/14790

#14781: Added test for SolutionTransfer with hp-refinement and manually set 
flags. (proposed by marcfehling; merged) 
https://github.com/dealii/dealii/pull/14781

#14771: Use try_compile in macro_check_compiler_setup.cmake (proposed by 
masterleinad; merged) https://github.com/dealii/dealii/pull/14771


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

#14812: Trouble finding trilinos (opened) 
https://github.com/dealii/dealii/issues/14812

#14807: FieldTransfer: coarsening FE_Nothing cells (opened) 
https://github.com/dealii/dealii/issues/14807

#14804: Final library compilation stage takes forever (opened) 
https://github.com/dealii/dealii/issues/14804

#14799: Nonlinear solvers (opened) https://github.com/dealii/dealii/issues/14799


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/63f3a728.df0a0220.85d9d.118fSMTPIN_ADDED_MISSING%40gmr-mx.google.com.


[deal.II] deal.II Newsletter #241

2023-02-13 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

#14793: doc: replace FE_DGRT with correct name (proposed by tjhei) 
https://github.com/dealii/dealii/pull/14793

#14792: doc: move simplex function from module (proposed by tjhei) 
https://github.com/dealii/dealii/pull/14792

#14791: Improvements to the NOXSolver class documentation (proposed by singima) 
https://github.com/dealii/dealii/pull/14791

#14790: doc: fix GridGenerator::convert_hypercube_to_simplex_mesh (proposed by 
tjhei) https://github.com/dealii/dealii/pull/14790

#14789: document MatrixFree mapping_update_flags (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/14789

#14788: Fix hp decision on coarse level cells. (proposed by marcfehling; 
merged) https://github.com/dealii/dealii/pull/14788

#14787: update CI badges in README (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/14787

#14786: Fix DEAL_II_COMPILER_HAS_ATTRIBUTE_ALWAYS_INLINE with -Werror (proposed 
by masterleinad; merged) https://github.com/dealii/dealii/pull/14786

#14785: Remove checks for CMake versions prior to 3.13.4 (proposed by 
masterleinad; merged) https://github.com/dealii/dealii/pull/14785

#14784: Implement ReferenceCell::face_vertex_location(). (proposed by bangerth) 
https://github.com/dealii/dealii/pull/14784

#14783: Suppress some nvcc warnings (proposed by masterleinad) 
https://github.com/dealii/dealii/pull/14783

#14782: Minor clarification in step-2. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/14782

#14781: Added test for SolutionTransfer with hp-refinement and manually set 
flags. (proposed by marcfehling) https://github.com/dealii/dealii/pull/14781

#14780: Make GridTools::volume() work with simplices. (proposed by drwells; 
merged) https://github.com/dealii/dealii/pull/14780

#14779: doc edits for KINSol (proposed by singima; merged) 
https://github.com/dealii/dealii/pull/14779

#14778: Fix a comment for types::boundary_id. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/14778

#14777: Standardize 2D/3D -> 2d/3d in a few strings. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/14777

#14776: Standardize 2D/3D -> 2d/3d in the tutorials. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/14776

#14775: Standardize 2D/3D -> 2d/3d in documentation comments. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/14775

#14774: Standardize 2D/3D -> 2d/3d in comments. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/14774

#14773: Fix warnings with Clang-15+Cuda (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/14773

#14772: Use Kokkos::abort directly (proposed by masterleinad) 
https://github.com/dealii/dealii/pull/14772

#14771: Use try_compile in macro_check_compiler_setup.cmake (proposed by 
masterleinad) https://github.com/dealii/dealii/pull/14771

#14770: Replace a ReferenceCell function call by a non-deprecated one. 
(proposed by bangerth; merged) https://github.com/dealii/dealii/pull/14770

#14769: Fix an assertion. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/14769

#14767: Minor cleanups in PETSc interfaces. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/14767

#14766: Extend test `find_all_active_cells_around_point_04` (proposed by 
mschreter; merged) https://github.com/dealii/dealii/pull/14766

#14765: Fixing random number generator function parser (proposed by pengfej; 
merged) https://github.com/dealii/dealii/pull/14765

#14763: Don't use static variables in tests (proposed by Rombur; merged) 
https://github.com/dealii/dealii/pull/14763

#14762: QProjector: minor orientation fixes. (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/14762

#14761: Fix the support points for FE_SimplexDGP. (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/14761

#14760: ignore external cast-function-type warnings (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/14760

#14759: changed std::pow to Utilities::pow in include/ source/ (proposed by 
Darth-Veidim; merged) https://github.com/dealii/dealii/pull/14759

#14758: Fix compiling with Trilinos+Sacado+Cuda (proposed by masterleinad) 
https://github.com/dealii/dealii/pull/14758

#14757: update changelog for release (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/14757

#14756: Bump docker/build-push-action from 3 to 4 (proposed by dependabot[bot]; 
merged) https://github.com/dealii/dealii/pull/14756

#14755: Add Kokkos::initialize and finalize to MPI_InitFinalize (proposed by 
Rombur; merged) https://github.com/dealii/dealii/pull/14755

#14754: Fix the type used to initialize a DerivativeForm from a tensor. 
(proposed by bangerth; merged) 

[deal.II] deal.II Newsletter #240

2023-02-02 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

#14754: Fix the type used to initialize a DerivativeForm from a tensor. 
(proposed by bangerth) https://github.com/dealii/dealii/pull/14754

#14753: Avoid __CUDA_ARCH__ in source code (proposed by masterleinad) 
https://github.com/dealii/dealii/pull/14753

#14752: Make sure all Kokkos headers are installed (proposed by simonsticko; 
merged) https://github.com/dealii/dealii/pull/14752

#14751: Fix compiling for the Kokkos CUDA backend using clang (proposed by 
masterleinad) https://github.com/dealii/dealii/pull/14751

#14747: Doc: Inform user how to exchange active FE indices on ghost cells. 
(proposed by marcfehling; merged) https://github.com/dealii/dealii/pull/14747

#14746: Remove a BOOST src directory we don't use. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/14746

#14745: Make the ExodusII reader work with line types. (proposed by drwells; 
merged) https://github.com/dealii/dealii/pull/14745

#14744: Some edits of the KINSol documentation. (proposed by singima; merged) 
https://github.com/dealii/dealii/pull/14744

#14743: Documentation: update to reflect recent CMake changes (proposed by 
tamiko; merged) https://github.com/dealii/dealii/pull/14743

#14742: CMake: Uniformly raise the minimum required version to 3.13.4 (proposed 
by tamiko; merged) https://github.com/dealii/dealii/pull/14742

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

#14740: Better document CommunicationPatternBase and derived classes. (proposed 
by bangerth; merged) https://github.com/dealii/dealii/pull/14740

#14739: Strip "-x cuda" from Trilinos flags without configured Cuda support 
(proposed by masterleinad; merged) https://github.com/dealii/dealii/pull/14739

#14738: CMake: do not use VERSION for interface targets for older CMake 
versions (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/14738

#14737: Use the new default orientation function in more places. (proposed by 
drwells; merged) https://github.com/dealii/dealii/pull/14737

#14736: Add support for partitioning with PetscSF (proposed by stefanozampini) 
https://github.com/dealii/dealii/pull/14736

#14735: partially address https://github.com/dealii/dealii/issues/14656 
(proposed by stefanozampini; merged) https://github.com/dealii/dealii/pull/14735

#14734: [9.4 branch] Mark a variable as extern (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/14734

#14733: Fix a couple tests for older Kokkos versions used by Trilinos (proposed 
by masterleinad; merged) https://github.com/dealii/dealii/pull/14733

#14732: Un-hardcode some orientation info in FE_SimplexP{_Bubbles}. (proposed 
by drwells; merged) https://github.com/dealii/dealii/pull/14732

#14731: Test cgal/cgal_intersect_simplices_1d_3d: constrain to version 5.5 or 
newer (proposed by tamiko; merged) https://github.com/dealii/dealii/pull/14731

#14730: Test lac/parallel_vector_21: do not use KOKKOS_IMPL_DO_NOT_USE_PRINTF 
and indeed use printf (proposed by tamiko) 
https://github.com/dealii/dealii/pull/14730

#14729: Test gmsh/gmsh_api_(01|02|03|04): add output variants (proposed by 
tamiko; merged) https://github.com/dealii/dealii/pull/14729

#14728: Fix find_all_active_cells_around_point() (proposed by peterrum) 
https://github.com/dealii/dealii/pull/14728

#14727: Get mapped vertices of face (proposed by jh66637) 
https://github.com/dealii/dealii/pull/14727

#14726: cgal: disable diagnostics when including CGAL headers (proposed by 
tamiko; merged) https://github.com/dealii/dealii/pull/14726

#14725: Boost: apply an upstream patch to silence -Wnonnull warnings (proposed 
by tamiko; merged) https://github.com/dealii/dealii/pull/14725

#14724: CMake: Silence a warning about HDF5_ROOT containing NOTFOUND (proposed 
by tamiko; merged) https://github.com/dealii/dealii/pull/14724

#14723: CMake: silence the CMAKE_CXX_EXTENSIONS warning when including Kokkos 
(proposed by tamiko; merged) https://github.com/dealii/dealii/pull/14723

#14722: Introduce DEAL_II_IF_CONSTEXPR (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/14722

#14719: Use initlog() in more tests. (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/14719

#14718: Add explicit instantiations for VectorTools::get_position_vector 
overload (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/14718

#14713: CMake: add_test(): allow concurrent runs of tests with shared targets 
(proposed by tamiko; merged) https://github.com/dealii/dealii/pull/14713

#14709: Miscellaneous improvements to ReferenceCell (proposed by drwells; 
merged) https://github.com/dealii/dealii/pull/14709

#14702: Set combined orientation (proposed by drwells; 

[deal.II] deal.II Newsletter #239

2023-01-24 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

#14719: Use initlog() in more tests. (proposed by drwells) 
https://github.com/dealii/dealii/pull/14719

#14718: Add explicit instantiations for VectorTools::get_position_vector 
overload (proposed by masterleinad) https://github.com/dealii/dealii/pull/14718

#14717: Fix ghost indices handling for PETSc vectors (proposed by 
stefanozampini) https://github.com/dealii/dealii/pull/14717

#14716: Minor fixes for PETSc testing (proposed by stefanozampini) 
https://github.com/dealii/dealii/pull/14716

#14715: Configure: enhance discovery of SLEPc (proposed by stefanozampini; 
merged) https://github.com/dealii/dealii/pull/14715

#14714: Make ensure_kokkos_initialized thread-safe (proposed by masterleinad) 
https://github.com/dealii/dealii/pull/14714

#14713: CMake: add_test(): allow concurrent runs of tests with shared targets 
(proposed by tamiko) https://github.com/dealii/dealii/pull/14713

#14712: Global-coarsening MG: test linear elements (proposed by peterrum; 
merged) https://github.com/dealii/dealii/pull/14712

#14710: ReferenceCell: consolidate some tables. (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/14710

#14709: Miscellaneous improvements to ReferenceCell (proposed by drwells) 
https://github.com/dealii/dealii/pull/14709

#14708: Added default constructor for CellWeights. (proposed by marcfehling; 
merged) https://github.com/dealii/dealii/pull/14708

#14707: Minor changes to PoisseuilleFlow. (proposed by marcfehling; merged) 
https://github.com/dealii/dealii/pull/14707

#14706: Remove reference cell namespace (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/14706

#14705: Fix race condition in implicit Kokkos initialization (proposed by 
masterleinad; merged) https://github.com/dealii/dealii/pull/14705

#14703: Test: sundials/n_vector: fix race condition (proposed by tamiko; 
merged) https://github.com/dealii/dealii/pull/14703

#14702: Set combined orientation (proposed by drwells) 
https://github.com/dealii/dealii/pull/14702

#14701: Also mark some variable instantiations as 'extern'. (proposed by 
bangerth) https://github.com/dealii/dealii/pull/14701

#14700: Improve two static_assert()s. (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/14700

#14699: include/deal.II/optimization/line_minimization.h add missing include 
(proposed by tamiko; merged) https://github.com/dealii/dealii/pull/14699

#14698: Declare the existence of explicit instantiations. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/14698

#14697: Add a comment for a recent patch. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/14697

#14696: Tests: optimization/* add missing includes (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/14696

#14684: PETScWrappers::MatrixBase implement clear_rows_columns (proposed by 
stefanozampini; merged) https://github.com/dealii/dealii/pull/14684

#14683: PETScWrappers::MPI::SparseMatrix: use SEQAIJ with one process (proposed 
by stefanozampini; merged) https://github.com/dealii/dealii/pull/14683

#14628: Convert CUDA tests to use Kokkos (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/14628

#14601: Align PETSc mpi comm with comm of PETSc Vec type, and expose VecNest 
type (proposed by luca-heltai; merged) 
https://github.com/dealii/dealii/pull/14601

#14361: introduce BoundingBox::is_neighbor() (proposed by jh66637; merged) 
https://github.com/dealii/dealii/pull/14361


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

#14711: Configuring with `Trilinos` somehow adds cuda flags on `expanse` 
(opened) https://github.com/dealii/dealii/issues/14711

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

#14695: mapping_collection not defined (opened) 
https://github.com/dealii/dealii/issues/14695


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 

[deal.II] deal.II Newsletter #238

2023-01-17 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

#14692: Fix two small things in FiniteElement. (proposed by drwells) 
https://github.com/dealii/dealii/pull/14692

#14691: Fix vertex numbering from deal to UCD (proposed by nlsmrg) 
https://github.com/dealii/dealii/pull/14691

#14690: Testsuite: run quick tests during build test (proposed by tamiko) 
https://github.com/dealii/dealii/pull/14690

#14689: CMake: Promote "tester-ng" to official regression tester (proposed by 
tamiko; merged) https://github.com/dealii/dealii/pull/14689

#14688: step-59, step-64, step85 keywords added (proposed by vyushut) 
https://github.com/dealii/dealii/pull/14688

#14687: Re-implement a compiler warning workaround (proposed by drwells; 
merged) https://github.com/dealii/dealii/pull/14687

#14686: PETScWrappers: add a couple of missing reinits (proposed by 
stefanozampini) https://github.com/dealii/dealii/pull/14686

#14685: PETScWrappers: improve preconditioner class (proposed by 
stefanozampini) https://github.com/dealii/dealii/pull/14685

#14684: PETScWrappers::MatrixBase implement clear_rows_columns (proposed by 
stefanozampini) https://github.com/dealii/dealii/pull/14684

#14683: PETScWrappers::MPI::SparseMatrix: use SEQAIJ with one process (proposed 
by stefanozampini) https://github.com/dealii/dealii/pull/14683

#14682: PETScWrappers::MPI::Vector use VectorBase contructor from Vec (proposed 
by stefanozampini; merged) https://github.com/dealii/dealii/pull/14682

#14681: Replace ucd to deal with local vertex numbering (proposed by nlsmrg; 
merged) https://github.com/dealii/dealii/pull/14681

#14680: Use switch statements in ReferenceCell (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/14680

#14679: Minor cleanup in the VTU writer. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/14679

#14678: do not finalize PETSc/SLEPc if not initalized from deal.II (proposed by 
stefanozampini; merged) https://github.com/dealii/dealii/pull/14678

#14677: Configure: support KOKKOS when found with PETSc (proposed by 
stefanozampini; merged) https://github.com/dealii/dealii/pull/14677

#14676: Minor changes to examples comments (proposed by stefanozampini; merged) 
https://github.com/dealii/dealii/pull/14676

#14675: Avoid a deprecated function in the last context where it is used. 
(proposed by bangerth; merged) https://github.com/dealii/dealii/pull/14675

#14674: Centralize translation between deal.II and VTK numbering for pyramids. 
(proposed by bangerth; merged) https://github.com/dealii/dealii/pull/14674

#14673: Replace ucd_to_deal with a local vertex numbering in GridGenerator 
(proposed by nlsmrg; merged) https://github.com/dealii/dealii/pull/14673

#14672: Augment documentation of the PETSc block sparse matrix. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/14672

#14671: Fix OpenMP flag for Kokkos >= 4.0.00 (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/14671

#14670: Implement ReferenceCell::contains_points() for the remaining reference 
cells. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/14670

#14669: Clean up BarycentricPolynomials a bit. (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/14669

#14668: Fix the name of a variable: 'ratio' instead of 'ration'. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/14668

#14666: Minor updates to bounding box documentation. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/14666

#14665: Remove comments that are no longer useful. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/14665

#14664: Deprecate functions in ReferenceCell and introduce replacements. 
(proposed by bangerth; merged) https://github.com/dealii/dealii/pull/14664

#14663: Make special casing in VTU output more explicit. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/14663

#14662: Use TriaObjectsOrientations in connectivity.h. (proposed by drwells; 
merged) https://github.com/dealii/dealii/pull/14662

#14661: Test output of a simplex cell with n_subdivisions=2. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/14661

#14660: Use std::array instead of a C-style array. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/14660

#14659: Do not write gratuitous output files into test directories. (proposed 
by bangerth; merged) https://github.com/dealii/dealii/pull/14659

#14658: Augment documentation of DataOutBase::Patch. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/14658

#14657: Hermite polynomials (proposed by ivweber) 
https://github.com/dealii/dealii/pull/14657

#14655: Improve grammar in error messages. (proposed by bangerth; merged) 

[deal.II] deal.II Newsletter #237

2023-01-09 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

#14649: Update clang-tidy checks for recent clang versions (proposed by 
masterleinad) https://github.com/dealii/dealii/pull/14649

#14647: Avoid using Tensor::begin_raw() et al. (proposed by drwells) 
https://github.com/dealii/dealii/pull/14647

#14646: Restrict some tests requiring p4est (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/14646

#14645: Add METIS to Docker image (proposed by blaisb; merged) 
https://github.com/dealii/dealii/pull/14645

#14643: Fix issue when adol-c is enabled (proposed by Rombur; merged) 
https://github.com/dealii/dealii/pull/14643

#14640: CMake: fix kokkos header installation (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/14640

#14639: Drop the requirement for Trilinos+Kokkos from 13.2 to 12.14.1 (proposed 
by masterleinad; merged) https://github.com/dealii/dealii/pull/14639

#14638: Be explicit about enabled and disabled dependencies in the Docker image 
(proposed by masterleinad; merged) https://github.com/dealii/dealii/pull/14638

#14636: delete old Jenkins setup (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/14636

#14635: CMake: Silence bogus Boost warning (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/14635

#14634: CMake: Do not set errand DEAL_II_TRILINOS_WITH* if Trilinos gets 
disabled (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/14634

#14633: Use Kokkos in functions struct replacing TBB (proposed by masterleinad) 
https://github.com/dealii/dealii/pull/14633

#14632: TridiagonalMatrix: change Assert to AssertThrow (proposed by nfehn) 
https://github.com/dealii/dealii/pull/14632

#14631: Fix up Trilinos+Kokos detection (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/14631

#14630: CMake: Silence a Kokkos warning about unset OMP_PROC_BIND (proposed by 
tamiko; merged) https://github.com/dealii/dealii/pull/14630

#14629: Address minor issues in Trilinos NOX wrappers (proposed by jppelteret; 
merged) https://github.com/dealii/dealii/pull/14629

#14628: Convert CUDA tests to use Kokkos (proposed by masterleinad) 
https://github.com/dealii/dealii/pull/14628

#14627: Get rid of VtuStream class (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/14627

#14626: Require Trilinos 13.2 if it includes Kokkos (proposed by masterleinad; 
merged) https://github.com/dealii/dealii/pull/14626

#14625: Improve documentation. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/14625

#14624: Move a function to ReferenceCell (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/14624

#14623: Fix compiler error for older version of GCC (proposed by jppelteret; 
merged) https://github.com/dealii/dealii/pull/14623

#14622: Remove some duplication; also simplify VTK code. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/14622

#14621: Remove DEAL_II_COMPILER_CUDA_AWARE (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/14621

#14620: Jenkins: run tests in random order (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/14620

#14618: Fix tests output: replace CUDA with Default (proposed by Rombur; 
merged) https://github.com/dealii/dealii/pull/14618

#14617: Fix broken ADOL-C tests (proposed by jppelteret; merged) 
https://github.com/dealii/dealii/pull/14617

#14616: Remove incorrect static_assert when using CUDA-aware MPI (proposed by 
Rombur; merged) https://github.com/dealii/dealii/pull/14616

#14615: CMake: avoid race conditions between concurrent prm tests (proposed by 
tamiko; merged) https://github.com/dealii/dealii/pull/14615

#14614: Isotropic refinement cleanup (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/14614

#14613: Better indent documentation of class Function. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/14613

#14612: small cleanup in tridiagonal_matrix.cc (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/14612

#14611: Extend hp support in FEInterfaceValues (proposed by jppelteret; merged) 
https://github.com/dealii/dealii/pull/14611

#14610: doc: add documentation for lapack library linking support (proposed by 
CodyGirl) https://github.com/dealii/dealii/pull/14610

#14607: [WIP] Generalize identity determination in FE_SimplexP (proposed by 
peterrum) https://github.com/dealii/dealii/pull/14607

#14605: Classical Gram-Schmidt for block vectors (proposed by peterrum) 
https://github.com/dealii/dealii/pull/14605

#14604: Add a dedicated class for orientation information. (proposed by 
drwells) https://github.com/dealii/dealii/pull/14604

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


[deal.II] deal.II Newsletter #236

2022-12-15 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

#14576: CI: new serial Jenkins (proposed by tjhei) 
https://github.com/dealii/dealii/pull/14576

#14575: Petsc mat mpi getter (proposed by luca-heltai) 
https://github.com/dealii/dealii/pull/14575

#14574: Petsc object reference (proposed by luca-heltai; merged) 
https://github.com/dealii/dealii/pull/14574

#14573: Simplify data passing to vtk_point_index_from_ijk(). (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/14573

#14572: Avoid more compiler warnings about array access (proposed by 
masterleinad; merged) https://github.com/dealii/dealii/pull/14572

#14571: [WIP] Convert device-aware MPI implementation for 
LinearAlgebra::distributed::Vector (proposed by masterleinad) 
https://github.com/dealii/dealii/pull/14571

#14570: Add weight_fe_q_dofs_by_entity_shifted() and 
compute_weights_fe_q_dofs_by_entity_shifted() (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/14570

#14569: Tensor product matrix collection fix vectorization (proposed by 
peterrum) https://github.com/dealii/dealii/pull/14569

#14568: [CI]: test all MPI tests (proposed by tjhei) 
https://github.com/dealii/dealii/pull/14568

#14567: CMake: enable dynamic linking for Windows (proposed by tamiko) 
https://github.com/dealii/dealii/pull/14567

#14566: Rename tests (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/14566

#14565: FEEvaluation: fix assert (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/14565

#14564: Add helper function to indicate power of two (proposed by peterrum; 
merged) https://github.com/dealii/dealii/pull/14564

#14563: ParameterHandler: add example for json (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/14563

#14562: ParameterHandler::add_parameter(): do not call action (proposed by 
peterrum) https://github.com/dealii/dealii/pull/14562

#14561: Generalize SolverRelaxation (proposed by peterrum) 
https://github.com/dealii/dealii/pull/14561

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

#14559: Tests: make mpiexec and numdiff optional (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/14559

#14558: Tests: convert quick tests into regular tests (proposed by tamiko; 
merged) https://github.com/dealii/dealii/pull/14558

#14557: Tests: performance: add missing valgrind wrapper (proposed by tamiko) 
https://github.com/dealii/dealii/pull/14557

#14556: Replace one more occurrence of dim-predicated loops. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/14556

#14555: [CI] disable old MPI build on Jenkins (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/14555

#14553: MatrixFree: disable overlap of communication/computation for FE_Nothing 
(proposed by peterrum) https://github.com/dealii/dealii/pull/14553

#14552: Modified Gram-Schmidt: add docu (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/14552

#14551: Take over #14540 and #14544 (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/14551

#14550: CMake: Bugfix: only export DEAL_II_GMSH_WITH_API if gmsh is configured 
(proposed by tamiko; merged) https://github.com/dealii/dealii/pull/14550

#14549: Add get/set_mesh_smoothing to python bindings. (proposed by adamqc; 
merged) https://github.com/dealii/dealii/pull/14549

#14548: Fix indentation in Jenkinsfile.mpi (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/14548

#14547: Add hp to FEInterfaceValues (proposed by fdrmrc) 
https://github.com/dealii/dealii/pull/14547

#14546: step-70: remove a dependency on boost. (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/14546

#14545: [9.4] Take over #14540 and #14544 (proposed by tamiko) 
https://github.com/dealii/dealii/pull/14545

#14544: CMake: Bugfix: only export DEAL_II_GMSH_WITH_API if gmsh is configured 
(proposed by tamiko) https://github.com/dealii/dealii/pull/14544

#14543: Address Wundefined-var-template (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/14543

#14542: [CI] add new MPI Jenkinsfile (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/14542

#14541: Fix some deprecations (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/14541

#14540: CMake: Ensure we use "-pthread" instead of "-lpthread" for thread 
support (proposed by tamiko; merged) https://github.com/dealii/dealii/pull/14540

#14539: Rearrange mapping related data (proposed by drwells) 
https://github.com/dealii/dealii/pull/14539

#14538: Added changelog for #14531 (proposed by luca-heltai; merged) 
https://github.com/dealii/dealii/pull/14538

#14537: Convert LinearAlgebra::distributed::Vector to Kokkos  (proposed by 

[deal.II] deal.II Newsletter #235

2022-12-06 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

#14536: Choose to initialize ghost elements with reinit(partitioner). (proposed 
by marcfehling) https://github.com/dealii/dealii/pull/14536

#14535: MarchingCubeAlgorithm<1>: Remove determination of a saddle point 
(proposed by mschreter) https://github.com/dealii/dealii/pull/14535

#14534: Don't use __has_trivial_copy (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/14534

#14533: Solver control history (proposed by vovannikov; merged) 
https://github.com/dealii/dealii/pull/14533

#14532: Remove a 'using' declaration in step-50 that is in the way. (proposed 
by bangerth; merged) https://github.com/dealii/dealii/pull/14532

#14531: Step 77: fix bug (proposed by tjhei) 
https://github.com/dealii/dealii/pull/14531

#14530: [9.4] Fix compilation of step-70. (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/14530

#14529: Fix compilation of step-70. (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/14529

#14528: CMake: remove a number of obscure configuration options (proposed by 
tamiko; merged) https://github.com/dealii/dealii/pull/14528

#14527: Add to the resources for programmers mentioned in step-1. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/14527

#14526: List step 12b in the list of tutorials. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/14526

#14524: Avoid using dealii:: qualified names. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/14524

#14523: Just do 'using namespace dealii' in main(). (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/14523

#14522: Reference the correct step. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/14522

#14521: Fix some warnings in tests (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/14521

#14520: Add support for the mold linker (proposed by masterleinad) 
https://github.com/dealii/dealii/pull/14520

#14519: fix warning: -1 assignment to unsigned (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/14519

#14517: update changelog for release (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/14517

#14516: step-85: add namespace to documentation (proposed by vyushut; merged) 
https://github.com/dealii/dealii/pull/14516

#14515: CMake: Bugfix: only add to the linker line what is needed (proposed by 
tamiko; merged) https://github.com/dealii/dealii/pull/14515

#14514: github/actions: install kokkos outside of deal.II source directory 
(proposed by tamiko; merged) https://github.com/dealii/dealii/pull/14514

#14513: Fix 'testing equality to None' python issue (proposed by luzpaz; 
merged) https://github.com/dealii/dealii/pull/14513

#14512: Fix typos in source function name (proposed by luzpaz; merged) 
https://github.com/dealii/dealii/pull/14512

#14511: Fix typos (proposed by luzpaz; merged) 
https://github.com/dealii/dealii/pull/14511

#14510: Use Kokkos in MemorySpaceData (proposed by masterleinad) 
https://github.com/dealii/dealii/pull/14510

#14509: github/actions: always configure and compile in separate build 
directory (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/14509

#14508: CMake: add define_interface_target() (proposed by tamiko) 
https://github.com/dealii/dealii/pull/14508

#14507: CMake: Remove pkg-config pc file generation (proposed by tamiko; 
merged) https://github.com/dealii/dealii/pull/14507

#14506: CMake: Remove deal.IIFeatureConfig.cmake (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/14506

#14505: update CI badges in readme (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/14505

#14504: Run the different parts of creating VTU output in parallel. (proposed 
by bangerth; merged) https://github.com/dealii/dealii/pull/14504

#14503: Reorder declaration and use of local lambda functions. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/14503

#14502: Add Threads::TaskGroup::return_values(). (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/14502

#14500: CMake: silence configure warnings for ArborX and Ginkgo (proposed by 
tamiko; merged) https://github.com/dealii/dealii/pull/14500

#14499: Update some commentary. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/14499

#14498: Remove a dependency in writing VTU files. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/14498

#14497: Bundled: avoid a warning in boost::serialization (proposed by tamiko; 
merged) https://github.com/dealii/dealii/pull/14497

#14496: base/work_stream: remove unused using declaration (proposed by tamiko; 
merged) https://github.com/dealii/dealii/pull/14496

#14495: CMake: 

[deal.II] deal.II Newsletter #234

2022-11-28 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

#14486: Add more reinit() to LA::distributed::BlockVector. (proposed by 
marcfehling; merged) https://github.com/dealii/dealii/pull/14486

#14485: Utilities::MPI::scatter: improve asserts (proposed by mschreter; 
merged) https://github.com/dealii/dealii/pull/14485

#14484: Some AffineConstraints instantiations. (proposed by marcfehling; 
merged) https://github.com/dealii/dealii/pull/14484

#14483: CMake: Update forgotten find_package() call (proposed by tamiko; 
merged) https://github.com/dealii/dealii/pull/14483

#14482: CMake: Rework process_feature() macro (proposed by tamiko) 
https://github.com/dealii/dealii/pull/14482

#14481: A few improvements to the PETSc classes (proposed by stefanozampini) 
https://github.com/dealii/dealii/pull/14481

#14480: CMake: Update CMake cache config documentation (proposed by tamiko) 
https://github.com/dealii/dealii/pull/14480

#14479: CMake: ensure some more, modern style rules (proposed by tamiko; 
merged) https://github.com/dealii/dealii/pull/14479

#14478: Remove obsolete doxygen tags. (proposed by marcfehling; merged) 
https://github.com/dealii/dealii/pull/14478

#14477: Inline most of the remaining functions in VtuStream into 
write_vtu_main(). (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/14477

#14476: Cleanup reinit() of PETSc/Trilinos BlockVector. (proposed by 
marcfehling) https://github.com/dealii/dealii/pull/14476

#14475: Introduce DEAL_II_HOST_DEV_ALWAYS_INLINE (proposed by masterleinad) 
https://github.com/dealii/dealii/pull/14475

#14474: Update documentation for deal.II+Cuda (proposed by masterleinad; 
merged) https://github.com/dealii/dealii/pull/14474

#14473: add a changelog for SparsityPatternBase. (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/14473

#14472: CMake: rename all find modules to DEAL_II_* (proposed by tamiko; 
merged) https://github.com/dealii/dealii/pull/14472

#14471: CMake: Remove _USER variables (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/14471

#14470: [9.4] Take over #14462 and #14465 (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/14470

#14469: add a news/changes entry (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/14469

#14468: CMake: Bugfix: only configure arborx with matching MPI configuration 
(proposed by tamiko; merged) https://github.com/dealii/dealii/pull/14468

#14467: CMake: Introduce a dealii:: namespace for targets and harmonize naming 
(proposed by tamiko; merged) https://github.com/dealii/dealii/pull/14467

#14466: CMake: search quietly for kokkos and avoid an unnecessary warning 
(proposed by tamiko; merged) https://github.com/dealii/dealii/pull/14466

#14465: CMake: always export compile_commands.json in deal.II and user projects 
(proposed by tamiko; merged) https://github.com/dealii/dealii/pull/14465

#14464: Add Utilities::MPI::scatter (proposed by mschreter; merged) 
https://github.com/dealii/dealii/pull/14464

#14463: CMake: lowercase all function and macro names (proposed by tamiko; 
merged) https://github.com/dealii/dealii/pull/14463

#14462: gitignore: ignore clangd files and directories (proposed by tamiko; 
merged) https://github.com/dealii/dealii/pull/14462

#14461: Test Kokkos on GPU (proposed by zjiaqi2018) 
https://github.com/dealii/dealii/pull/14461

#14460: Fix more warnings about unused variables (proposed by kronbichler; 
merged) https://github.com/dealii/dealii/pull/14460

#14459: clang-tidy: use line breaks in config, remove nonexistent check 
(proposed by tamiko; merged) https://github.com/dealii/dealii/pull/14459

#14457: Add Kokkos link libraries to Trilinos link libraries (proposed by 
masterleinad) https://github.com/dealii/dealii/pull/14457

#14456: Fix PETScWrappers::PreconditionBase warnings (proposed by masterleinad) 
https://github.com/dealii/dealii/pull/14456

#14455: CMake: remove forgotten GO = statement in tpetra compatibility check 
(proposed by tamiko; merged) https://github.com/dealii/dealii/pull/14455

#14453: Replace DEAL_II_CUDA_HOST_DEV with KOKKOS_FUNCTION (proposed by Rombur; 
merged) https://github.com/dealii/dealii/pull/14453

#14452: GridGenerator: avoid a warning in release mode (proposed by tamiko; 
merged) https://github.com/dealii/dealii/pull/14452

#14451: Sparsity pattern base cleanup (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/14451

#14450: Bump actions/checkout from 2 to 3 (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/14450

#14449: Move declaration of vtu_stream to where it is used. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/14449

#14448: Use variable-sized std::array instead of fixed number of arguments. 
(proposed by bangerth; merged) 

[deal.II] deal.II Newsletter #233

2022-11-17 Thread 'Rene Gassmoeller' via deal.II User Group
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 

[deal.II] deal.II Newsletter #232

2022-11-04 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

#14391: Correctly handle unpacking empty objects (proposed by gassmoeller) 
https://github.com/dealii/dealii/pull/14391

#14389: Document a restriction on ConsensusAlgorithms::serial(). (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/14389

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

#14387: FEEvaluation: precompile for n_q_points==2*fe_degree (proposed by 
peterrum) https://github.com/dealii/dealii/pull/14387

#14386: MatrixFreeOperators::LaplaceOperator vectorization width 1 (proposed by 
sebproell; merged) https://github.com/dealii/dealii/pull/14386

#14385: Fast hanging-node algorithm for FE_Q_iso_Q1 (proposed by peterrum; 
merged) https://github.com/dealii/dealii/pull/14385

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

#14383: ShapeInfo: Implement evaluation of derivatives on faces (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/14383

#14381: Make the error message for non-integer IDs in UNV files clearer. 
(proposed by drwells; merged) https://github.com/dealii/dealii/pull/14381

#14380: Allow FEImmersedSurfaceValues to take a MappingFEField (proposed by 
fdrmrc; merged) https://github.com/dealii/dealii/pull/14380

#14378: Fix some warnings. (proposed by marcfehling; merged) 
https://github.com/dealii/dealii/pull/14378

#14376: fe_index: added changelog. (proposed by marcfehling; merged) 
https://github.com/dealii/dealii/pull/14376

#14371: Generalize precompilation of TensorProductMatrixSymmetricSum (proposed 
by peterrum; merged) https://github.com/dealii/dealii/pull/14371

#14366: TensorProductMatrix: with arbitrary number of lanes (proposed by 
peterrum; merged) https://github.com/dealii/dealii/pull/14366

#14356: Report error and abort in CollectiveMutex during stack unwinding 
(proposed by gassmoeller; merged) https://github.com/dealii/dealii/pull/14356


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

#14390: A tutorial on an eigensolver for linear elasticity (opened) 
https://github.com/dealii/dealii/issues/14390

#14382: Does dealii support 1D problem. (opened and closed) 
https://github.com/dealii/dealii/issues/14382

#14379: grid_in  unv file error (opened and closed) 
https://github.com/dealii/dealii/issues/14379


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/63653716.1c0a0220.cc865.2adcSMTPIN_ADDED_MISSING%40gmr-mx.google.com.


[deal.II] deal.II Newsletter #231

2022-10-28 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

#14377: Move cuda to nvcc wrapper kokkos (proposed by masterleinad) 
https://github.com/dealii/dealii/pull/14377

#14376: fe_index: added changelog. (proposed by marcfehling) 
https://github.com/dealii/dealii/pull/14376

#14374: Fix dimension selection in COMSOL mphtxt reader. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/14374

#14371: Generalize precompilation of TensorProductMatrixSymmetricSum (proposed 
by peterrum) https://github.com/dealii/dealii/pull/14371

#14370: Rename process_dof_gather() to process_dofs() (proposed by peterrum) 
https://github.com/dealii/dealii/pull/14370

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

#14367: Fix documentation misprint, modulus should be norm. (proposed by 
simonsticko) https://github.com/dealii/dealii/pull/14367

#14366: TensorProductMatrix: with arbitrary number of lanes (proposed by 
peterrum) https://github.com/dealii/dealii/pull/14366

#14365: Make Kokkos a required dependency and bundle Kokkos 3.7.00 (proposed by 
masterleinad) https://github.com/dealii/dealii/pull/14365

#14364: [WIP] Catch exceptions in consensus algorithm (proposed by gassmoeller) 
https://github.com/dealii/dealii/pull/14364

#14349: SolverGMRES: add classical Gram-Schmidt (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/14349

#14225: Adjust interface in 'dofs' folder to new datatype 'types::fe_index'. 
(proposed by marcfehling; merged) https://github.com/dealii/dealii/pull/14225


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

#14375: Missing library name(s) for IntelMKL in FindSCALAPACK (opened) 
https://github.com/dealii/dealii/issues/14375

#14373: Impossible to build dealii (Trilinos problem) on Macbook pro with M1Pro 
(opened and closed) https://github.com/dealii/dealii/issues/14373

#14372: Question about cmake Tpetra detection (opened) 
https://github.com/dealii/dealii/issues/14372

#14368: Epetra, Tpetra, and MueLu (opened) 
https://github.com/dealii/dealii/issues/14368

#14363: Missing cmake policy CMP0074 for use of -DBOOST_DIR (opened) 
https://github.com/dealii/dealii/issues/14363

#14358: dealii:when i use Gmsh to generate .msh file, Number of 
coupling nodes: 0 (closed) https://github.com/dealii/dealii/issues/14358


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/635bfc97.1c0a0220.f9852.18caSMTPIN_ADDED_MISSING%40gmr-mx.google.com.


[deal.II] deal.II Newsletter #230

2022-10-19 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

#14362: Execute explicit instantiations of compute_intersection_of_cells() 
(proposed by jh66637) https://github.com/dealii/dealii/pull/14362

#14361: introduce BoundingBox::is_neighbor() (proposed by jh66637) 
https://github.com/dealii/dealii/pull/14361

#14360: Get vertices in CGAL order on face (proposed by jh66637) 
https://github.com/dealii/dealii/pull/14360

#14357: Fix two typos in ConsensusAlgorithm::NBX (proposed by gassmoeller) 
https://github.com/dealii/dealii/pull/14357

#14356: [WIP] Remove communication in CollectiveMutex during stack unwinding 
(proposed by gassmoeller) https://github.com/dealii/dealii/pull/14356

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

#14354: VectorizedArray: mixed load/store (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/14354

#14353: Add tolerance to avoid empty CGAL intersections due to roundoff 
(proposed by jh66637) https://github.com/dealii/dealii/pull/14353

#14352: [WIP] Add TrilinosWrappers::SolverBelos (proposed by peterrum) 
https://github.com/dealii/dealii/pull/14352

#14351: GitHub CI: update Ubuntu version (proposed by peterrum) 
https://github.com/dealii/dealii/pull/14351

#14350: Refactor SolverGMRES::modified_gram_schmidt (proposed by peterrum; 
merged) https://github.com/dealii/dealii/pull/14350

#14349: SolverGMRES: add classical Gram-Schmidt (proposed by peterrum) 
https://github.com/dealii/dealii/pull/14349

#14348: Implement ReferenceCell::n_face_orientations(). (proposed by drwells; 
merged) https://github.com/dealii/dealii/pull/14348

#14339: Fix some doxygen problems. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/14339


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

#14359: CGAL intersection bug (opened) 
https://github.com/dealii/dealii/issues/14359

#14358: dealii:when i use Gmsh to generate .msh file, Number of 
coupling nodes: 0 (opened) https://github.com/dealii/dealii/issues/14358


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/63501f12.050a0220.b3a20.a520SMTPIN_ADDED_MISSING%40gmr-mx.google.com.


[deal.II] deal.II Newsletter #229

2022-10-12 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

#14347: Remove an unnecessary semicolon. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/14347

#14346: Add process_dofs_vectorized_transpose() variants with constant_offset 
(proposed by peterrum) https://github.com/dealii/dealii/pull/14346

#14345: Fix transform() doc entry (proposed by gfcas; merged) 
https://github.com/dealii/dealii/pull/14345

#14344: MatrixFree: add early check for ghosted dst vector (proposed by 
sebproell; merged) https://github.com/dealii/dealii/pull/14344

#14343: MatrixFree pre and post operation for loop() (proposed by sebproell) 
https://github.com/dealii/dealii/pull/14343

#14342: [WIP] MatrixFree: mark ghost vertices (proposed by peterrum) 
https://github.com/dealii/dealii/pull/14342

#14341: Fix check for same face type (proposed by kronbichler; merged) 
https://github.com/dealii/dealii/pull/14341

#14340: Fix bug in FieldTransfer for ghosted vectors (proposed by sebproell; 
merged) https://github.com/dealii/dealii/pull/14340

#14330: Implement some memory_consumption() functions (proposed by peterrum; 
merged) https://github.com/dealii/dealii/pull/14330


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/6346e491.1c0a0220.c48eb.35a5SMTPIN_ADDED_MISSING%40gmr-mx.google.com.


[deal.II] deal.II Newsletter #228

2022-10-05 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

#14339: Fix some doxygen problems. (proposed by bangerth) 
https://github.com/dealii/dealii/pull/14339

#14337: [WIP] Allow filling RPE from outside (proposed by jh66637) 
https://github.com/dealii/dealii/pull/14337

#14336: Correct a date in a file name in the changelog. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/14336

#14335: Run doxygen with threads. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/14335

#14334: Fix a  type list. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/14334

#14332: Add NOX wrapper (proposed by peterrum) 
https://github.com/dealii/dealii/pull/14332

#14331: TensorProductMatrixSymmetricSumCollection: allow to disable compression 
(proposed by peterrum) https://github.com/dealii/dealii/pull/14331

#14330: Implement some memory_consumption() functions (proposed by peterrum) 
https://github.com/dealii/dealii/pull/14330

#14329: Use std::all_of (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/14329

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

#14327: [WIP] Precompute inverse diagonal (FDM) (proposed by peterrum) 
https://github.com/dealii/dealii/pull/14327

#14326: Fix messages about cgal versions (proposed by fdrmrc; merged) 
https://github.com/dealii/dealii/pull/14326

#14325: Update required cgal version for intersection routines (proposed by 
fdrmrc; merged) https://github.com/dealii/dealii/pull/14325

#14324: MatrixFree: Store indices of Dirichlet constrained DoFs as `-1` 
(proposed by kronbichler) https://github.com/dealii/dealii/pull/14324

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

#14317: Create compute_weights_fe_q_dofs_by_entity() (proposed by peterrum; 
merged) https://github.com/dealii/dealii/pull/14317

#14316: Add TensorProductMatrixCreator namespace (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/14316

#14315: FEEvaluation::submit_xxx(): Create some local copies to reduce 
potential aliasing (proposed by kronbichler; merged) 
https://github.com/dealii/dealii/pull/14315

#14314: Reduce organizational overhead/pointer chasing in FEEvaluation/read 
(proposed by kronbichler; merged) https://github.com/dealii/dealii/pull/14314

#14305: GridTools::MarchingCubeAlgorithm: add 1d implementation (proposed by 
mschreter; merged) https://github.com/dealii/dealii/pull/14305

#14304: Remove SparsityPatternBase, for now. (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/14304


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

#14338: Generalized interface to collect CGAL intersections (opened) 
https://github.com/dealii/dealii/issues/14338

#14333: MatrixFree with different quadratures for each row leads to an 
exception while FEEvaluation::evaluate (opened and closed) 
https://github.com/dealii/dealii/issues/14333

#14322: Compilation failure with CGAL <5.5 when compiling with clang (opened 
and closed) https://github.com/dealii/dealii/issues/14322


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/633daa14.050a0220.d5726.5194SMTPIN_ADDED_MISSING%40gmr-mx.google.com.


[deal.II] deal.II Newsletter #227

2022-09-28 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

#14321: Rotate for dim=1 spacedim=2 (proposed by peterrum) 
https://github.com/dealii/dealii/pull/14321

#14320: CGAL: use dealii's constexpr Utilities::pow instead of std::pow 
(proposed by tamiko; merged) https://github.com/dealii/dealii/pull/14320

#14318: Versions for 
weight_fe_q_dofs_by_entity/compute_weights_fe_q_dofs_by_entity with Q4 storage 
(proposed by peterrum) https://github.com/dealii/dealii/pull/14318

#14317: Create compute_weights_fe_q_dofs_by_entity() (proposed by peterrum) 
https://github.com/dealii/dealii/pull/14317

#14316: Add TensorProductMatrixCreator namespace (proposed by peterrum) 
https://github.com/dealii/dealii/pull/14316

#14315: FEEvaluation::submit_xxx(): Create some local copies to reduce 
potential aliasing (proposed by kronbichler) 
https://github.com/dealii/dealii/pull/14315

#14314: Reduce organizational overhead/pointer chasing in FEEvaluation/read 
(proposed by kronbichler) https://github.com/dealii/dealii/pull/14314

#14313: Do not dereference cend (proposed by dangars; merged) 
https://github.com/dealii/dealii/pull/14313

#14312: Restructure includes of FloatingPointComparator (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/14312

#14311: Simplify code in DoFInfo::read_dof_indices (proposed by kronbichler; 
merged) https://github.com/dealii/dealii/pull/14311

#14310: Add shortcut to detect whether a DoF is constrained (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/14310

#14309: Fix exponential complexity of FloatingPointComparator with nesting 
(proposed by kronbichler; merged) https://github.com/dealii/dealii/pull/14309

#14308: CGAL: fix warnings and fix compilation with cgal 5.5 (proposed by 
tamiko; merged) https://github.com/dealii/dealii/pull/14308

#14307: Use FloatingPointComparator in TriangulationDescription (proposed by 
peterrum; merged) https://github.com/dealii/dealii/pull/14307

#14306: Add missing header file (proposed by kronbichler; merged) 
https://github.com/dealii/dealii/pull/14306

#14305: GridTools::MarchingCubeAlgorithm: add 1d implementation (proposed by 
mschreter) https://github.com/dealii/dealii/pull/14305

#14304: Remove SparsityPatternBase, for now. (proposed by drwells) 
https://github.com/dealii/dealii/pull/14304

#14303: Increase precision of time written in xdmf output (proposed by 
sebproell; merged) https://github.com/dealii/dealii/pull/14303

#14302: Clean up weight_fe_q_dofs_by_entity (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/14302

#14301: Do not mention update_cell_dof_indices_cache in documentation (proposed 
by kronbichler; merged) https://github.com/dealii/dealii/pull/14301

#14300: Do not default initialize projection matrix in GMRES (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/14300

#14299: Remove reference to update_cell_dof_indices_cache (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/14299

#14298: Use FloatingPointComparator in 
TensorProductMatrixSymmetricSumCollection (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/14298

#14297: TensorProductMatrixSymmetricSumCollection: store matrices/vectors flat 
(proposed by peterrum; merged) https://github.com/dealii/dealii/pull/14297

#14296: Rename FPArrayComparator -> FloatingPointComparator (proposed by 
peterrum; merged) https://github.com/dealii/dealii/pull/14296

#14246: Improve error message. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/14246

#14234: Normal flux constraints: map DoF indices to vector DoF indices 
(proposed by zjiaqi2018; merged) https://github.com/dealii/dealii/pull/14234


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

#14319: Compilation failure on the tester when compiling with clang (cgal 
5.2.2) (opened and closed) https://github.com/dealii/dealii/issues/14319

#13411: Setup of MatrixFree got slower since release 9.3 (closed) 
https://github.com/dealii/dealii/issues/13411


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 

[deal.II] deal.II Newsletter #226

2022-09-21 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

#14296: Rename FPArrayComparator -> FloatingPointComparator (proposed by 
peterrum) https://github.com/dealii/dealii/pull/14296

#14295: Make variable names in tensor_product_matrix.h more consistent 
(proposed by peterrum; merged) https://github.com/dealii/dealii/pull/14295

#14294: Remove template parameter from FPArrayComparator (proposed by peterrum; 
merged) https://github.com/dealii/dealii/pull/14294

#14293: Extend VectorizedArrayTrait (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/14293

#14292: Windows action: archive library only if merged into master (proposed by 
peterrum; merged) https://github.com/dealii/dealii/pull/14292

#14291: Tensor product matrix creator (proposed by peterrum) 
https://github.com/dealii/dealii/pull/14291

#14290: find_neighbor_type with customizable tolerance (proposed by jh66637; 
merged) https://github.com/dealii/dealii/pull/14290

#14289: Add TensorProductMatrixSymmetricSumCache (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/14289

#14288: TensorProductMatrixSymmetricSum: switch to pointers (proposed by 
peterrum; merged) https://github.com/dealii/dealii/pull/14288

#14287: Vector reductions: Unroll a loop in case of vectorization (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/14287

#14286: Revise some operations in compute_index_owner_internal (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/14286

#14285: Remove credits from DataOutBase (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/14285

#14284: Add DataOutBase::CompressionLevel::ascii (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/14284

#14283: Avoid undefined behavior warning (proposed by mschreter; merged) 
https://github.com/dealii/dealii/pull/14283

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

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

#14280: Make sure not to work with possibly uninitialized variables (proposed 
by kronbichler; merged) https://github.com/dealii/dealii/pull/14280

#14279: internal::MatrixFreeFunctions::ConstraintInfo: switch data type 
(proposed by peterrum; merged) https://github.com/dealii/dealii/pull/14279

#14278: PreconditionRelaxation/Chebyshev fixes (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/14278

#14276: Fix high-order output for vtu in parallel (proposed by peterrum; 
merged) https://github.com/dealii/dealii/pull/14276

#14273: Refactor TensorProductMatrixSymmetricSum (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/14273

#14272: Add support for FE_Nothin in CUDA matrix-free (proposed by Rombur; 
merged) https://github.com/dealii/dealii/pull/14272

#14271: PreconditionChebyshev: add specialization for A and P with ranges 
(proposed by peterrum; merged) https://github.com/dealii/dealii/pull/14271

#14270: Triangulation: implement global_*_cell_index_partitioner() (proposed by 
peterrum; merged) https://github.com/dealii/dealii/pull/14270

#14258: DataOutResample for multiple components (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/14258

#14183: Fix Manifold<3, 3>::normal_vector (proposed by zjiaqi2018; merged) 
https://github.com/dealii/dealii/pull/14183

#13677: Petsc bddc preconditioner (proposed by nabw; merged) 
https://github.com/dealii/dealii/pull/13677


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

#14277: `GridOutFlags::Vtk`: add flag to enable ascii output (opened and 
closed) https://github.com/dealii/dealii/issues/14277

#14275: `DataOut::write_vtu_in_parallel`+ 
`DataOutBase::VtkFlags::write_higher_order_cells` + `dim==3`: distorted cells 
in Paraview  (opened and closed) https://github.com/dealii/dealii/issues/14275

#14274: Triangulation distributed without p4est (opened and closed) 
https://github.com/dealii/dealii/issues/14274

#14263: Undefined behavior warning: 
`Triangulation::execute_refinement_isotropic/execute_coarsening` (closed) 
https://github.com/dealii/dealii/issues/14263

#14247: VectorizedArray Warning (closed) 
https://github.com/dealii/dealii/issues/14247

#14176: no normal flux normal vector issue with half_hyper_shell (closed) 
https://github.com/dealii/dealii/issues/14176


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 

[deal.II] deal.II Newsletter #225

2022-09-14 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

#14271: [WIP] PreconditionChebyshev: add specialization for A and P with ranges 
(proposed by peterrum) https://github.com/dealii/dealii/pull/14271

#14270: Triangulation: implement global_*_cell_index_partitioner() (proposed by 
peterrum) https://github.com/dealii/dealii/pull/14270

#14269: Use ExcNeedsMPI (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/14269

#14268: Ensure that every header which uses numeric_limits includes limits. 
(proposed by drwells; merged) https://github.com/dealii/dealii/pull/14268

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

#14266: [WIP] Add SolutionSerialization (proposed by peterrum) 
https://github.com/dealii/dealii/pull/14266

#14265: Fix unused warning (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/14265

#14264: Avoid warning about function that might not be inlinable (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/14264

#14262: `invalid_fe_index`: fix deprecated warning (proposed by mschreter; 
merged) https://github.com/dealii/dealii/pull/14262

#14261: Linking error: make 
`dealii::internal::SolverGMRESImplementation::solve_triangular()` inline 
(proposed by mschreter; merged) https://github.com/dealii/dealii/pull/14261

#14259: GT::distributed_compute_point_locations(): project reference points 
onto cell (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/14259

#14258: DataOutResample for multiple components (proposed by peterrum) 
https://github.com/dealii/dealii/pull/14258

#14257: Clean up implementation in SolverBicgstab (proposed by kronbichler; 
merged) https://github.com/dealii/dealii/pull/14257

#14256: Revise vector operations in SolverIDR to improve performance (proposed 
by kronbichler; merged) https://github.com/dealii/dealii/pull/14256

#14255: [9.4] Fix PETSc version detection. (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/14255

#14254: Vectorize more work in reductions of vector operations (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/14254

#14253: Copy scalars in vector operations to make compiler optimize more 
(proposed by kronbichler; merged) https://github.com/dealii/dealii/pull/14253

#14252: Provide inlined fast code path for Vector::reinit(Vector&) (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/14252

#14251: SolverGMRES: Add 'batched' mode for reduced overhead at small sizes 
(proposed by kronbichler; merged) https://github.com/dealii/dealii/pull/14251

#14250: cleanup some more header inclusions. (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/14250

#14249: Fix another warning about an unused variable (proposed by kronbichler; 
merged) https://github.com/dealii/dealii/pull/14249

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

#14246: Improve error message. (proposed by bangerth) 
https://github.com/dealii/dealii/pull/14246

#14245: PreconditionRelaxation: add specialization (proposed by peterrum; 
merged) https://github.com/dealii/dealii/pull/14245

#14096: Function to restrict matrices (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/14096


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

#14263: Undefined behavior warning: 
`Triangulation::execute_refinement_isotropic/execute_coarsening` (opened) 
https://github.com/dealii/dealii/issues/14263

#14260: Implement `ReferenceCell::project_to_unit_cell()` (opened) 
https://github.com/dealii/dealii/issues/14260

#14247: VectorizedArray Warning (opened) 
https://github.com/dealii/dealii/issues/14247


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/632216cb.a70a0220.9261d.ba5cSMTPIN_ADDED_MISSING%40gmr-mx.google.com.


[deal.II] deal.II Newsletter #224

2022-09-07 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

#14245: PreconditionRelaxation: add specialization (proposed by peterrum) 
https://github.com/dealii/dealii/pull/14245

#14244: DiagonalMatrix: specialize for LA:d:V (proposed by peterrum) 
https://github.com/dealii/dealii/pull/14244

#14243: [WIP] TensorProductMatrixSymmetricSum for matrices with rows/columns 
filled with zero (proposed by peterrum) 
https://github.com/dealii/dealii/pull/14243

#14242: PreconditionChebyshev: reduce number of writes by one (proposed by 
peterrum; merged) https://github.com/dealii/dealii/pull/14242

#14241: Fix a warning (proposed by kronbichler; merged) 
https://github.com/dealii/dealii/pull/14241

#14240: FEEvaluation: Create temporary copy of Jacobian matrix in submit_XXX 
(proposed by kronbichler; merged) https://github.com/dealii/dealii/pull/14240

#14239: MatrixFree: Fix assertion in presence of FE_Nothing (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/14239

#14238: Add specializations of PreconditionRelaxation functions (proposed by 
peterrum; merged) https://github.com/dealii/dealii/pull/14238

#14237: Specialize EvaluatorTensorProduct for non-templated 
execution (proposed by peterrum) https://github.com/dealii/dealii/pull/14237

#14236: support XDMF writing with ranks without cells (proposed by tjhei) 
https://github.com/dealii/dealii/pull/14236

#14235: fix: step-50 PETSc (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/14235

#14234: Normal flux constraints: map DoF indices to vector DoF indices 
(proposed by zjiaqi2018) https://github.com/dealii/dealii/pull/14234

#14232: Enable SolverIDR for block vectors (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/14232

#14231: Doc update in GridTools. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/14231

#14230: Remove an outdated comment. Link to step-19. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/14230

#14229: Clarify a comment for one of the particle generators. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/14229

#14228: Precompile TensorProductMatrixSymmetricSum kernels (proposed by 
peterrum; merged) https://github.com/dealii/dealii/pull/14228

#14227: Set another OMP environment variable. (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/14227

#14226: MatrixFree laplace operator: Restructure computation of diagonal 
(proposed by kronbichler; merged) https://github.com/dealii/dealii/pull/14226

#14225: Adjust interface in 'dofs' folder to new datatype 'types::fe_index'. 
(proposed by marcfehling) https://github.com/dealii/dealii/pull/14225

#14224: Fix bug in matrix-free operators regarding diagonal (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/14224

#14223: Update output (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/14223

#14222: Fix test case with clang compiler (proposed by kronbichler; merged) 
https://github.com/dealii/dealii/pull/14222

#14221: Fuse some loops in Triangulation::execute_coarsening (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/14221

#14220: Merge two loops in setup of triangulation (proposed by kronbichler; 
merged) https://github.com/dealii/dealii/pull/14220

#14219: MatrixFree: Fix bug in setup of new cell_index for MG (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/14219

#14218: Avoid warning about unused variable (proposed by kronbichler; merged) 
https://github.com/dealii/dealii/pull/14218

#14216: Add specializations of PreconditionChebyshev functions (proposed by 
peterrum; merged) https://github.com/dealii/dealii/pull/14216

#14215: Fix PETSc version detection. (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/14215

#14214: Fix docker build (proposed by bergbauer; merged) 
https://github.com/dealii/dealii/pull/14214

#14213: Clarify comments about get_generalized_support_points(). (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/14213

#14212: Move invalid_fe_index to numbers. (proposed by marcfehling; merged) 
https://github.com/dealii/dealii/pull/14212

#14211: Update checks for AD-types. (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/14211

#14210: Move active_fe_index_type to types. (proposed by marcfehling; merged) 
https://github.com/dealii/dealii/pull/14210

#14209: Optimize PreconditionRelaxation (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/14209

#14208: Added get/set functions for future FE indices. (proposed by 
marcfehling; merged) https://github.com/dealii/dealii/pull/14208

#14207: Change get_active_fe_indices() to return the result. (proposed by 
marcfehling; merged) 

[deal.II] deal.II Newsletter #223

2022-08-16 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

#14190: FEEvaluationData: add virtual destructor (proposed by peterrum) 
https://github.com/dealii/dealii/pull/14190

#14188: Fix typo in step-52. (proposed by marcfehling; merged) 
https://github.com/dealii/dealii/pull/14188

#14187: Remove now redundant namespace identifier. (proposed by marcfehling; 
merged) https://github.com/dealii/dealii/pull/14187

#14186: Misc header cleanup (proposed by drwells) 
https://github.com/dealii/dealii/pull/14186

#14185: Move 'using MPI_Comm = int' et al to a separate header. (proposed by 
drwells) https://github.com/dealii/dealii/pull/14185

#14184: Fix some theory in step-44 introduction (proposed by jppelteret; 
merged) https://github.com/dealii/dealii/pull/14184

#14183: Fix half_hyper_shell() manifold (proposed by zjiaqi2018) 
https://github.com/dealii/dealii/pull/14183

#14182: Remove some template specializations for QAnisotropic. (proposed by 
drwells; merged) https://github.com/dealii/dealii/pull/14182

#14181: Move Threads::Mutex to a dedicated header. (proposed by drwells; 
merged) https://github.com/dealii/dealii/pull/14181

#14180: Cmake: fix wrong cxx flags with single kokkos (proposed by RichardYCJ) 
https://github.com/dealii/dealii/pull/14180

#14178: Add second version of TensorProductMatrixSymmetricSum::apply_inverse() 
(proposed by peterrum) https://github.com/dealii/dealii/pull/14178

#14177: Add second version to initialize MFF::ConstraintInfo (proposed by 
peterrum; merged) https://github.com/dealii/dealii/pull/14177

#14174: Don't include Sacado.hpp in base/numbers.h. (proposed by drwells; 
merged) https://github.com/dealii/dealii/pull/14174


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

#14189: Internal error in SolutionTransfer (opened) 
https://github.com/dealii/dealii/issues/14189

#14179: cmake fail to set CXX_FLAGS correctly with independent external kokkos  
(opened) https://github.com/dealii/dealii/issues/14179

#14176: no normal flux normal vector issue with half_hyper_shell (opened) 
https://github.com/dealii/dealii/issues/14176


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/62fb6ab3.7b0a0220.104bf.3c39SMTPIN_ADDED_MISSING%40gmr-mx.google.com.


[deal.II] deal.II Newsletter #222

2022-08-04 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

#14175: Implement TensorProductMatrixSymmetricSumBase::memory_consumption() 
(proposed by peterrum) https://github.com/dealii/dealii/pull/14175

#14174: Don't include Sacado.hpp in base/numbers.h. (proposed by drwells) 
https://github.com/dealii/dealii/pull/14174

#14173: Added hp::Refinement::copy_future_fe_indices(). (proposed by 
marcfehling) https://github.com/dealii/dealii/pull/14173

#14172: Fix typos in tests/ subdirectory (proposed by luzpaz; merged) 
https://github.com/dealii/dealii/pull/14172

#14171: [WIP] Enable VectorTools::project() for DoFHandler in hp-mode. 
(proposed by marcfehling) https://github.com/dealii/dealii/pull/14171

#14168: Fix various typos (proposed by luzpaz; merged) 
https://github.com/dealii/dealii/pull/14168

#14165: Fix generation of the tutorial graph. (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/14165

#14101: Vector tools project 1 (proposed by gfcas; merged) 
https://github.com/dealii/dealii/pull/14101

#14039: Implement isend/irecv functions. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/14039


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

#14170: Trilinos AD `declared to take const reference, but implicit declaration 
would take non-const` error during compilation of user program (opened) 
https://github.com/dealii/dealii/issues/14170

#14169: `VectorTools::project` not implemented for hp parallel (opened) 
https://github.com/dealii/dealii/issues/14169

#14163: Tutorial graph is no longer working (closed) 
https://github.com/dealii/dealii/issues/14163


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/62ebed10.050a0220.e5935.12e8SMTPIN_ADDED_MISSING%40gmr-mx.google.com.


[deal.II] deal.II Newsletter #221

2022-07-28 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

#14167: No normal flux constraints on level meshes (proposed by zjiaqi2018) 
https://github.com/dealii/dealii/pull/14167

#14166: Dimension independent intersection between deal.II cells (proposed by 
fdrmrc) https://github.com/dealii/dealii/pull/14166

#14165: Fix generation of the tutorial graph. (proposed by drwells) 
https://github.com/dealii/dealii/pull/14165

#14162: Fix a typo in deal.II/base/numbers.h (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/14162

#14161: Bump the minimum PETSc version number. (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/14161

#14160: Documentation:manifold normal vector (proposed by zjiaqi2018) 
https://github.com/dealii/dealii/pull/14160

#14159: FEPointEvaluation fix compilation for float (proposed by bergbauer) 
https://github.com/dealii/dealii/pull/14159

#14158: CMake: remove find_package override (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/14158

#14157: Fix doxygen groups in many places  (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/14157

#14156: [9.4] Make ConsensusAlgorithm deprecations early-deprecated instead. 
(proposed by drwells; merged) https://github.com/dealii/dealii/pull/14156

#14152: matrix-free FEEvaluation: initialize with nan (proposed by tjhei; 
merged) https://github.com/dealii/dealii/pull/14152

#14132: MatrixFree: Implement get_affine_constraints() (proposed by bergbauer; 
merged) https://github.com/dealii/dealii/pull/14132

#14131: Add test for FEEvaluationShift with FE_Q and FE_DGQ (proposed by 
bergbauer; merged) https://github.com/dealii/dealii/pull/14131

#14104: AssertThrow for BlockVector usage in MassOperator (proposed by gfcas; 
merged) https://github.com/dealii/dealii/pull/14104

#14041: `QSimplex::compute_affine_transformation()` in co-dimension one 
and two (proposed by fdrmrc; merged) https://github.com/dealii/dealii/pull/14041

#9937: Remove PETScWrappers deprecations (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/9937


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

#14164: AffineConstraints distribute_local_to_global not throwing errors using 
Trilinos Matrices (opened) https://github.com/dealii/dealii/issues/14164

#14163: Tutorial graph is no longer working (opened) 
https://github.com/dealii/dealii/issues/14163

#14095: doxygen errors (closed) https://github.com/dealii/dealii/issues/14095

#14065: Configuration: Checking for parallel HDF5 fails (closed) 
https://github.com/dealii/dealii/issues/14065


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/62e2b299.170a0220.50827.45f2SMTPIN_ADDED_MISSING%40gmr-mx.google.com.


[deal.II] deal.II Newsletter #220

2022-07-21 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

#14156: [9.4] Make ConsensusAlgorithm deprecations early-deprecated instead. 
(proposed by drwells) https://github.com/dealii/dealii/pull/14156

#14155: Make all template specialization of FPE compile for float (proposed by 
peterrum) https://github.com/dealii/dealii/pull/14155

#14154: FEEvaluation: Fix two places where the address sanitizer complained 
(proposed by kronbichler; merged) https://github.com/dealii/dealii/pull/14154

#14153: MatrixFree: Use separate data arrays for two separate evaluators 
(proposed by kronbichler; merged) https://github.com/dealii/dealii/pull/14153

#14152: matrix-free FEEvaluation: initialize with nan (proposed by tjhei) 
https://github.com/dealii/dealii/pull/14152

#14151: The number of faces for anisotropic grids (in 3d) is wrong. (proposed 
by luca-heltai) https://github.com/dealii/dealii/pull/14151

#14150: Fix tria::has_hanging_nodes for anisotropically refined meshes 
(proposed by luca-heltai) https://github.com/dealii/dealii/pull/14150

#14149: Declare 'enable_if_all_t' in analogy to std::enable_if_t. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/14149

#14148: Replace std::enable_if by std::enable_if_t throughout. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/14148

#14147: Do not use 'typename' where not necessary. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/14147

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

#14145: Added quicktests to Intel workflow. (proposed by marcfehling; merged) 
https://github.com/dealii/dealii/pull/14145

#14144: Expand a discussion in step-58. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/14144

#14143: Add some functions to convert active cell iterators (proposed by 
jppelteret; merged) https://github.com/dealii/dealii/pull/14143

#14142: Fix type in FPE (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/14142

#14141: p:d:GridRefinement: actually accept other types of triangulations 
(proposed by peterrum; merged) https://github.com/dealii/dealii/pull/14141

#14140: Generalized VT::point_gradients() for multiple components (proposed by 
peterrum) https://github.com/dealii/dealii/pull/14140

#14139: Use pre-increment operator. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/14139

#14138: Reduce the volume of communication somewhat. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/14138

#14137: Use only enough bits in an enum as necessary. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/14137

#14136: Clarify documentation of p::s::T. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/14136

#14135: Add some assertions about hypercube reference cells. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/14135

#14134: Fix a reference. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/14134

#14132: MatrixFree: Implement get_affine_constraints() (proposed by bergbauer) 
https://github.com/dealii/dealii/pull/14132

#14126: Ensure to look at square of tolerances (proposed by kronbichler; 
merged) https://github.com/dealii/dealii/pull/14126

#14125: Fix reference entry (proposed by gfcas; merged) 
https://github.com/dealii/dealii/pull/14125

#14123: parallel intermediate out: compression levels (proposed by tjhei; 
merged) https://github.com/dealii/dealii/pull/14123

#14115: MatrixFree DoFInfo: Break out from some expensive loops (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/14115

#14114: DoFHandlerPolicy: Avoid one write access to an array (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/14114

#14089: Added explicit instantiations of 
DoFTools::distribute_cell_to_dof_vector (proposed by a-shahba; merged) 
https://github.com/dealii/dealii/pull/14089

#14073: Communicate refinement flags in p:s:T (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/14073

#14072: p:d:GridRefinement: accept other types of triangulations (proposed by 
peterrum; merged) https://github.com/dealii/dealii/pull/14072

#13990: Non-affine piola transformation for mf RaviartThomas (proposed by 
NiklasWik; merged) https://github.com/dealii/dealii/pull/13990


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

#14133: Is `point_inside()` failing with an hyper_ball? (opened) 
https://github.com/dealii/dealii/issues/14133

#13639: build fail on riscv64 arch (closed) 
https://github.com/dealii/dealii/issues/13639

#13574: deal.II Release 9.4 - post-release tasks (closed) 
https://github.com/dealii/dealii/issues/13574

#13477: Quicktests fail with Intel oneAPI suite. (closed) 

[deal.II] deal.II Newsletter #219

2022-07-13 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

#14131: Add test for FEEvaluationShift with FE_Q (proposed by bergbauer) 
https://github.com/dealii/dealii/pull/14131

#14130: Introduce inverse of MF::get_cell_iterator() (proposed by peterrum) 
https://github.com/dealii/dealii/pull/14130

#14128: Simplify a function by using range-based for loops. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/14128

#14126: Ensure to look at square of tolerances (proposed by kronbichler) 
https://github.com/dealii/dealii/pull/14126

#14125: Fix reference entry (proposed by gfcas) 
https://github.com/dealii/dealii/pull/14125

#14124: Introduce Utilities::MPI::prefix_sum (proposed by peterrum) 
https://github.com/dealii/dealii/pull/14124

#14123: parallel intermediate out: compression levels (proposed by tjhei) 
https://github.com/dealii/dealii/pull/14123

#14122: Add FEFaceEvaluation::at_boundary() and boundary_id() (proposed by 
peterrum) https://github.com/dealii/dealii/pull/14122

#14121: Add MatrixFreeTools::ElementBirthAndDeathMatrixFree (proposed by 
peterrum) https://github.com/dealii/dealii/pull/14121

#14120: Simplify some MPI code. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/14120

#14119: FEEvaluationBase::read_write_operation Chose correct code path for 
neighbors and activated mask (proposed by bergbauer; merged) 
https://github.com/dealii/dealii/pull/14119

#14118: get_line_indices_of_cell: Add specialization for tetrahedra (proposed 
by kronbichler; merged) https://github.com/dealii/dealii/pull/14118

#14116: Introduce copy_boundary_ids in merge_triangulation() (proposed by 
jh66637; merged) https://github.com/dealii/dealii/pull/14116

#14115: MatrixFree DoFInfo: Break out from some expensive loops (proposed by 
kronbichler) https://github.com/dealii/dealii/pull/14115

#14114: DoFHandlerPolicy: Avoid one write access to an array (proposed by 
kronbichler) https://github.com/dealii/dealii/pull/14114

#14113: (9.4) fix changelog entry (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/14113

#14112: reformat comment block (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/14112

#14111: fix changelog entry (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/14111

#14110: Implement parallel intermediate output (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/14110

#14109: Add Vector::zero_out_ghost_values (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/14109

#14108: Update outdated documentation of Partitioner (proposed by peterrum; 
merged) https://github.com/dealii/dealii/pull/14108

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

#14105: Improve error message by providing a clickable link (proposed by 
tamiko; merged) https://github.com/dealii/dealii/pull/14105

#14104: AssertThrow for BlockVector usage in MassOperator (proposed by gfcas) 
https://github.com/dealii/dealii/pull/14104

#14103: Better document what tolerance to use in MappingCartesian. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/14103

#14102: Add AssertIndexRange (proposed by gfcas; merged) 
https://github.com/dealii/dealii/pull/14102

#14099: RPE: allow to evaluate cell-data vector (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/14099

#14088: [9.4] Take over multiple PRs (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/14088

#13924: Provide internal function for faster access of 3D cell->line_index 
(proposed by kronbichler; merged) https://github.com/dealii/dealii/pull/13924


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

#14129: Warning when compiling TableHandler (opened) 
https://github.com/dealii/dealii/issues/14129

#14127: compute_local_to_global_vertex_index_map does not wait for 
communication to finish (opened) https://github.com/dealii/dealii/issues/14127

#14117: BarycentricPolynomial::value() optimizations - get rid of `pow` 
(opened) https://github.com/dealii/dealii/issues/14117

#14106: Robustness of FEEvaluation's pre-compiled evaluation routines (opened) 
https://github.com/dealii/dealii/issues/14106


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 

[deal.II] deal.II Newsletter #218

2022-07-06 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

#14101: Vector tools project 1 (proposed by gfcas) 
https://github.com/dealii/dealii/pull/14101

#14099: [WIP] RPE: allow to evaluate cell-data vector (proposed by peterrum) 
https://github.com/dealii/dealii/pull/14099

#14097: Clean cgal utilities (proposed by fdrmrc) 
https://github.com/dealii/dealii/pull/14097

#14096: Function to restrict matrices (proposed by peterrum) 
https://github.com/dealii/dealii/pull/14096

#14094: [CI] limit parallelism in docker master build (proposed by tjhei) 
https://github.com/dealii/dealii/pull/14094

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

#14092: Bugfix: Use correct relative tolerance in MappingCartesian assert. 
(proposed by gassmoeller; merged) https://github.com/dealii/dealii/pull/14092

#14091: DoFTools::make_periodicity_constraints move asserts (proposed by 
peterrum; merged) https://github.com/dealii/dealii/pull/14091

#14090: FEEvaluationBase::read_write_operation_contiguous enable masking 
(proposed by bergbauer; merged) https://github.com/dealii/dealii/pull/14090

#14089: Added explicit instantiations of 
DoFTools::distribute_cell_to_dof_vector (proposed by a-shahba) 
https://github.com/dealii/dealii/pull/14089

#14088: [9.4] Take over multiple PRs (proposed by peterrum) 
https://github.com/dealii/dealii/pull/14088

#14087: doxygen: fix errors in formulas (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/14087

#14086: doxygen: fix SymmetricTensor friends (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/14086

#14085: FEEvaluationBase::read_write_operation case 3: enable masking (proposed 
by peterrum; merged) https://github.com/dealii/dealii/pull/14085

#14084: Be explicit regarding zero tolerance in merge_triangulations (proposed 
by peterrum; merged) https://github.com/dealii/dealii/pull/14084

#14083: Fix bug when we have no line dofs in assignment/renumbering of face mg 
dofs (proposed by kronbichler; merged) 
https://github.com/dealii/dealii/pull/14083

#14082: Restructure execute_refinement(Triangulation<3, spacedim>&) (proposed 
by kronbichler; merged) https://github.com/dealii/dealii/pull/14082

#14081: Add function to extract raw coarsen flags (proposed by kronbichler; 
merged) https://github.com/dealii/dealii/pull/14081

#14080: Use get_line_indices_of_cell in DoFHandlerPolicy (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/14080

#14076: Use faster data structure to compute matrix-free renumbering (proposed 
by kronbichler; merged) https://github.com/dealii/dealii/pull/14076

#14059: find_active_cell_around_point should only find cells with marked 
vertices (proposed by jh66637; merged) 
https://github.com/dealii/dealii/pull/14059

#14055: Add cross-references for global indices (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/14055

#13962: Support HDF5 output with one rank having no cells (proposed by tjhei; 
merged) https://github.com/dealii/dealii/pull/13962


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

#14100: GridTools::compute_active_cell_halo_layer() not working for PBC 
(opened) https://github.com/dealii/dealii/issues/14100

#14098: Performance of FEEvaluation::read_dof_values with masks (opened) 
https://github.com/dealii/dealii/issues/14098

#14095: doxygen errors (opened) https://github.com/dealii/dealii/issues/14095

#14053: Sundials test fail. (closed) 
https://github.com/dealii/dealii/issues/14053


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/62c5b19c.1c69fb81.343d9.c355SMTPIN_ADDED_MISSING%40gmr-mx.google.com.


[deal.II] deal.II Newsletter #217

2022-06-29 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

#14078: Remove remaining deprecations (proposed by masterleinad) 
https://github.com/dealii/dealii/pull/14078

#14077: Fix warning about possibly uninitialized variables (proposed by 
kronbichler) https://github.com/dealii/dealii/pull/14077

#14076: Use faster data structure to compute matrix-free renumbering (proposed 
by kronbichler) https://github.com/dealii/dealii/pull/14076

#14075: MGTransferBlockMatrixFree: allow to copy form/to other type of block 
vector (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/14075

#14074: Add MGTransferGlobalCoarsening::min_level() and max_level() (proposed 
by peterrum; merged) https://github.com/dealii/dealii/pull/14074

#14073: Communicate refinement flags in p:s:T (proposed by peterrum) 
https://github.com/dealii/dealii/pull/14073

#14072: p:d:GridRefinement: accept other types of triangulations (proposed by 
peterrum) https://github.com/dealii/dealii/pull/14072

#14071: [WIP] Implement helpers for constitutive laws parameterised by 
(coupled) invariants (proposed by jppelteret) 
https://github.com/dealii/dealii/pull/14071

#14070: Remove CellId::to_cell (proposed by masterleinad) 
https://github.com/dealii/dealii/pull/14070

#14068: Remove the cell dof indices cache (proposed by kronbichler) 
https://github.com/dealii/dealii/pull/14068

#14067: Speed up ReferenceCell::standard_vs_true_line_orientation (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/14067

#14066: Speed up DoFAccessorImplementation::get_dof_indices (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/14066

#14064: Remove deprecated XDMFEntry::get_xdmf_content (proposed by 
masterleinad; merged) https://github.com/dealii/dealii/pull/14064

#14063: DoFAccessor: Streamline access to dof indices (proposed by kronbichler; 
merged) https://github.com/dealii/dealii/pull/14063

#14062: Simplify assertion by AssertIndexRange (proposed by kronbichler; 
merged) https://github.com/dealii/dealii/pull/14062

#14061: Fix some VectorizedArrayTypes for non-default vectorization (proposed 
by sebproell; merged) https://github.com/dealii/dealii/pull/14061

#14060: Remove deprecated header file lac/parallel_block_vector.h  (proposed by 
masterleinad; merged) https://github.com/dealii/dealii/pull/14060

#14059: find_active_cell_around_point should only find cells with marked 
vertices (proposed by jh66637) https://github.com/dealii/dealii/pull/14059

#14058: Fix a few MatrixFree tests (proposed by kronbichler; merged) 
https://github.com/dealii/dealii/pull/14058

#14057: Fix bug in MatrixFree::reinit for MG levels with empty process 
(proposed by kronbichler; merged) https://github.com/dealii/dealii/pull/14057

#14056: HDF XDMF entry: store reference cell (proposed by tjhei) 
https://github.com/dealii/dealii/pull/14056

#14055: Add cross-references for global indices (proposed by peterrum) 
https://github.com/dealii/dealii/pull/14055

#14054: Remove trailing const (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/14054

#14052: Small improvement for IndexSet::add_ranges_internal (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/14052

#14051: DoFHandlerPolicy: Speed up function renumber_face_mg_dofs (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/14051

#14050: User projects: Make sure that CMAKE_CUDA_HOST_COMPILER is set. 
(proposed by tamiko; merged) https://github.com/dealii/dealii/pull/14050

#14049: fix a warning when compiling with cuda support (proposed by tamiko; 
merged) https://github.com/dealii/dealii/pull/14049

#14048: Remove unqualified ContantFunction and ZeroFunction (proposed by 
masterleinad; merged) https://github.com/dealii/dealii/pull/14048

#14047: Remove DoFHandler's initialize and set_fe (proposed by masterleinad; 
merged) https://github.com/dealii/dealii/pull/14047

#14046: Mark two tests that depend on p4est as such. (proposed by drwells; 
merged) https://github.com/dealii/dealii/pull/14046

#14045: Include index_set.h in two more tests. (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/14045

#14044: step-81: Mention example step in the tutorial lists (proposed by 
tamiko; merged) https://github.com/dealii/dealii/pull/14044

#14043: Remove deprecated QProjector member functions (proposed by 
masterleinad; merged) https://github.com/dealii/dealii/pull/14043

#14042: Slightly reword DataOutResample's documentation. (proposed by drwells; 
merged) https://github.com/dealii/dealii/pull/14042

#14041: `QSimplex::compute_affine_transformation()` in co-dimension one 
(proposed by fdrmrc) https://github.com/dealii/dealii/pull/14041

#14040: Remove deprecated DoFTools functions (proposed by masterleinad; merged) 

[deal.II] deal.II Newsletter #216

2022-06-22 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

#14033: [9.4] Takeover #14032: Disable HYPRE in the Tvmult test. (proposed by 
drwells) https://github.com/dealii/dealii/pull/14033

#14032: Disable HYPRE in the Tvmult test. (proposed by drwells) 
https://github.com/dealii/dealii/pull/14032

#14031: Remove deprecated atomicAdd_wrapper (proposed by masterleinad) 
https://github.com/dealii/dealii/pull/14031

#14030: [9.4] Take over #14029: Work around a GCC-12 warning about array 
accesses. (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/14030

#14029: Work around a GCC-12 warning about array accesses. (proposed by 
drwells; merged) https://github.com/dealii/dealii/pull/14029

#14028: [9.4] Take over #14015: Make get_cell_range_category() more consistent 
with get_cell_category() (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/14028

#14027: [9.4] Take over #14026: Fix warning of gcc-12 with gather_pd/ps 
instructions (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/14027

#14026: Fix warning of gcc-12 with gather_pd/ps instructions (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/14026

#14025: Query ghost index set only once in Partitioner::global_to_local 
(proposed by kronbichler; merged) https://github.com/dealii/dealii/pull/14025

#14024: Do not add locally owned dofs to ghost set during construction 
(proposed by kronbichler) https://github.com/dealii/dealii/pull/14024

#14023: Remove obsolete header file (proposed by kronbichler; merged) 
https://github.com/dealii/dealii/pull/14023

#14022: Reduce header inclusions of index_set.h in evaluation_kernels (proposed 
by kronbichler) https://github.com/dealii/dealii/pull/14022

#14021: Restructure inline functions of IndexSet (proposed by kronbichler) 
https://github.com/dealii/dealii/pull/14021

#14020: Avoid unnecessary locally_relevant_dofs in mg_transfer_internal 
(proposed by kronbichler) https://github.com/dealii/dealii/pull/14020

#14019: MGConstrainedDoFs::clear_user_constraints (proposed by zjiaqi2018; 
merged) https://github.com/dealii/dealii/pull/14019

#14018: Better describe what FullMatrix is and does. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/14018

#14017: Minor text improvements in a tutorial documentation. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/14017

#14016: Add reference to fast hanging-node algo and global coarsening (proposed 
by peterrum; merged) https://github.com/dealii/dealii/pull/14016

#14015: Make get_cell_range_category() more consistent with get_cell_category() 
(proposed by peterrum; merged) https://github.com/dealii/dealii/pull/14015

#14014: Add test (MG+DG+hp) (proposed by peterrum) 
https://github.com/dealii/dealii/pull/14014

#14013: MatrixFree: allow categorization of ghost cells (proposed by peterrum; 
merged) https://github.com/dealii/dealii/pull/14013

#14012: [9.4] Take over #14010 and #14011 (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/14012

#14011: Can't use ReferenceCells in switch-case. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/14011

#14010: Can't use ReferenceCells in switch-case. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/14010

#14009: [9.4] Fix compilation with clang-13. (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/14009

#14007: Improve documentation of MF::AD::cell_vectorization_category (proposed 
by peterrum; merged) https://github.com/dealii/dealii/pull/14007

#14006: Fix compilation with clang-13. (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/14006

#14005: MatrixFree: improve assert (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/14005

#14003: [9.4] Take over #14002, Fix failing symengine tests (proposed by 
tamiko; merged) https://github.com/dealii/dealii/pull/14003

#14002: Fix failing symengine tests (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/14002

#14001: Update AUTHORS.md (proposed by NiklasWik; merged) 
https://github.com/dealii/dealii/pull/14001

#13999: [9.4] CMake: Remove taskflow configure (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/13999

#13998: [9.4] remove p4est_bug_01 test (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/13998

#13995: switch all DEAL_II_DEPRECATED_EARLY to DEAL_II_DEPRECATED (proposed by 
tamiko; merged) https://github.com/dealii/dealii/pull/13995

#13994: update VERSION (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/13994

#13993: Update tag file references for release. (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/13993

#13992: Update changelog for release (proposed by tamiko; merged) 

[deal.II] deal.II Newsletter #215

2022-06-15 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

#13976: Fix generalized support points of FE_RaviartThomasNodal (proposed by 
kronbichler) https://github.com/dealii/dealii/pull/13976

#13975: Fix the MPI window functions with clang. (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/13975

#13974: CMake: Use default Kokkos' DefaultNodeType in Tpetra test (proposed by 
tamiko; merged) https://github.com/dealii/dealii/pull/13974

#13973: CMake: Use deal.II's global index type in Tpetra compatibility test 
(proposed by tamiko; merged) https://github.com/dealii/dealii/pull/13973

#13971: Remove remaining @author (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/13971

#13969: CMake: use full compiler/linker flags for trilinos sanity checks 
(proposed by tamiko; merged) https://github.com/dealii/dealii/pull/13969

#13968: Run codespell (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/13968

#13967: Explicitly template function pointwise_definiteness(..) (proposed by 
simonsticko; merged) https://github.com/dealii/dealii/pull/13967

#13964: contrib/python_bindings: set PYTHON_EXECUTABLE (proposed by tamiko; 
merged) https://github.com/dealii/dealii/pull/13964

#13963: CMake: Use -Wno-pass-failed for clang (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/13963

#13962: Support HDF5 output with one rank having no cells (proposed by tjhei) 
https://github.com/dealii/dealii/pull/13962

#13961: Fix more PETSc complex tests (proposed by kronbichler; merged) 
https://github.com/dealii/dealii/pull/13961

#13960: Fix two tests with complex PETSc (proposed by kronbichler; merged) 
https://github.com/dealii/dealii/pull/13960

#13959: test cgal/cgal_surface_mesh_01: add output variant (proposed by tamiko; 
merged) https://github.com/dealii/dealii/pull/13959

#13958: precondition.h: switch from Assert to AssertThrow (proposed by 
peterrum; merged) https://github.com/dealii/dealii/pull/13958

#13956: test cgal/cgal_surface_mesh_01: Update output (proposed by tamiko; 
merged) https://github.com/dealii/dealii/pull/13956

#13955: CGAL: fix header includes (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/13955

#13954: GridGenerator: put CGAL implementation into own compilation unit 
(proposed by tamiko; merged) https://github.com/dealii/dealii/pull/13954

#13953: Replace 2*dim (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/13953

#13952: MatrixFree: Fix element-centric loops with different cell geometry 
compression (proposed by kronbichler; merged) 
https://github.com/dealii/dealii/pull/13952

#13951: MatrixFree: Simplify some code in initialization of DoF indices 
(proposed by kronbichler) https://github.com/dealii/dealii/pull/13951

#13950: CMake: use -Wno-misleading-indentation for grid_generator.cc 
compilation unit (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/13950

#13947: DoFAccessor: Run process_dof_indices only on FE entities with DoFs 
(proposed by kronbichler) https://github.com/dealii/dealii/pull/13947

#13946: Simplify access to number of raw objects (proposed by kronbichler) 
https://github.com/dealii/dealii/pull/13946

#13945: Fix TriaAccessor::is_ghost_on_level for case without MPI (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/13945

#13944: slepc/solver_04: adjust tolerances (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/13944

#13943: test mpi/p4est_bug_01: Update test. (proposed by tamiko) 
https://github.com/dealii/dealii/pull/13943

#13941: test ginkgo/solver: adjust tolerances (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/13941

#13940: tests cgal/* add output variants (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/13940

#13939: test distributed_grids/large_vtu_01: fix test (proposed by tamiko; 
merged) https://github.com/dealii/dealii/pull/13939

#13938: test distributed_grids/3d_refinement_09: refactor test and add an 
output variant (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/13938

#13937: test base/unsubscribe_subscriptor: add output variant (proposed by 
tamiko) https://github.com/dealii/dealii/pull/13937

#13936: test algorithms/general_data_storage_01: add output variant (proposed 
by tamiko) https://github.com/dealii/dealii/pull/13936

#13935: Fix some test typenames for GCC-12. (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/13935

#13934: Arkode linear jacobians (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/13934

#13933: Fix some CGAL tests. (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/13933

#13932: Move implementation of implicit_function() into .cc file (proposed by 
fdrmrc; merged) 

[deal.II] deal.II Newsletter #214

2022-06-01 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

#13884: Use map::find rather than insert to avoid creating temporary (proposed 
by kronbichler) https://github.com/dealii/dealii/pull/13884

#13883: Remove another inclusion of hanging_nodes_internal.h. Documentation. 
(proposed by kronbichler) https://github.com/dealii/dealii/pull/13883

#13882: Fix typo in documentation for UpdateFlags (proposed by masterleinad) 
https://github.com/dealii/dealii/pull/13882

#13880: fix parallel .vtu missing footer (proposed by tjhei) 
https://github.com/dealii/dealii/pull/13880

#13879: add large vtu test (proposed by tjhei) 
https://github.com/dealii/dealii/pull/13879

#13878: Reduce run time of matrix-free RT tests (proposed by kronbichler; 
merged) https://github.com/dealii/dealii/pull/13878

#13876: update large IO test output (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/13876

#13875: vtu zlib: assert max size (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/13875

#13874: Allow to call communicate_mg_ghost_cells in 1D (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/13874

#13873: MatrixFree: Use faster data structure to detect parents of cells 
(proposed by kronbichler) https://github.com/dealii/dealii/pull/13873

#13872: MatrixFree: Do not construct hanging nodes structure for non-adapted 
meshes (proposed by kronbichler) https://github.com/dealii/dealii/pull/13872

#13871: Remove header inclusion (proposed by kronbichler; merged) 
https://github.com/dealii/dealii/pull/13871

#13870: MatrixFree: Avoid use of deprecated n_components_filled (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/13870

#13869: Speed up the function MatrixFree::n_active_entries_per_cell_batch 
(proposed by kronbichler; merged) https://github.com/dealii/dealii/pull/13869

#13868: FEInterfaceValues: add more tests  (proposed by zjiaqi2018) 
https://github.com/dealii/dealii/pull/13868

#13867: LargeCount MPI_write/read_at (proposed by zjiaqi2018) 
https://github.com/dealii/dealii/pull/13867

#13866: Clean up PolynomialsRaviartThomas (proposed by kronbichler) 
https://github.com/dealii/dealii/pull/13866

#13865: Prevent endless particle loop during refinement (proposed by 
gassmoeller; merged) https://github.com/dealii/dealii/pull/13865

#13864: Make VectorTools::project compile with complex numbers (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/13864

#13863: Fixing grammar mistakes in comments (proposed by pengfej; merged) 
https://github.com/dealii/dealii/pull/13863

#13862: Fix a grammar mistake. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/13862

#13861: Add a missing assertion in the XDMF writer. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/13861

#13860: Properly tag an output file. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/13860

#13858: Fix bug for global coarsening: Must allow invalid proc id (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/13858

#13857: Ignore *.ptvu files from tutorial steps (proposed by gfcas) 
https://github.com/dealii/dealii/pull/13857

#13856: Bump actions/checkout from 2 to 3 (proposed by dependabot[bot]; merged) 
https://github.com/dealii/dealii/pull/13856

#13855: Step-81: add authors to intro.dox (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/13855

#13854: Optimize Utilities::pack/unpack for empty objects. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/13854

#13853: Avoid some uses of Triangulation::user_flags (proposed by kronbichler) 
https://github.com/dealii/dealii/pull/13853

#13852: missing changelog entries (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/13852

#13851: Use LargeCount MPI_write_at and MPI_read_at functions (proposed by 
pengfej; merged) https://github.com/dealii/dealii/pull/13851

#13850: wrapcomments.py update (proposed by tjhei) 
https://github.com/dealii/dealii/pull/13850

#13849: doxygen comments: @ref fixes (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/13849

#13847: Add a changelog for the new CutFEM functionality in NonMatching. 
(proposed by simonsticko; merged) https://github.com/dealii/dealii/pull/13847

#13846: Restore compatibility with OpenCASCADE >= 7.6.0 (proposed by 
marcfehling) https://github.com/dealii/dealii/pull/13846

#13845: Introduce DEAL_II_OPENCASCADE_VERSION_GTE (proposed by marcfehling; 
merged) https://github.com/dealii/dealii/pull/13845

#13844: Suppress some unused variable warnings when we don't have muParser. 
(proposed by drwells; merged) https://github.com/dealii/dealii/pull/13844

#13843: Fix FESystem::initialize for pyramids/wedges (proposed by peterrum; 
merged) 

[deal.II] deal.II Newsletter #213

2022-05-25 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

#13820: Refactor grid fixup functions (proposed by drwells) 
https://github.com/dealii/dealii/pull/13820

#13819: [9.3] Take over doxygen fixes (proposed by tamiko) 
https://github.com/dealii/dealii/pull/13819

#13818: Step-40: Remove an unmatched single quote (proposed by tamiko) 
https://github.com/dealii/dealii/pull/13818

#13817: Remove now obsolete CellDataTransferBuffer (proposed by kronbichler) 
https://github.com/dealii/dealii/pull/13817

#13816: Use GridTools::exchange_cell_data_on_ghosts for DoF renumbering 
(proposed by kronbichler) https://github.com/dealii/dealii/pull/13816

#13815: ParameterHandler::print_parameters(): Demangle JSON (proposed by 
mschreter) https://github.com/dealii/dealii/pull/13815

#13814: NonMatching: Compute exact coupling mass matrix and exact sparsity 
pattern (proposed by fdrmrc) https://github.com/dealii/dealii/pull/13814

#13813: Utilities: Fix compile error on certain compilers (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/13813

#13812: Remove unnecessary MPI barriers (proposed by kronbichler) 
https://github.com/dealii/dealii/pull/13812

#13811: Optimize Utilities::pack for std::vector> 
(proposed by kronbichler) https://github.com/dealii/dealii/pull/13811

#13810: Assert reference cell is hypercube in Discrete*QuadratureGenerator 
(proposed by simonsticko; merged) https://github.com/dealii/dealii/pull/13810

#13809: Adjust output of tests using PreconditionChebyshev (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/13809

#13808: [9.5] Removed hp::DoFHandler. (proposed by marcfehling) 
https://github.com/dealii/dealii/pull/13808

#13807: Compute Quadrature formula over a general poly (proposed by fdrmrc) 
https://github.com/dealii/dealii/pull/13807

#13806: [WIP] FEPointEvaluation for dim!=spacedim (proposed by peterrum) 
https://github.com/dealii/dealii/pull/13806

#13805: Fix test dependencies (proposed by drwells) 
https://github.com/dealii/dealii/pull/13805

#13804: Fix doxygen entry Chronopoulos1989. (proposed by marcfehling; merged) 
https://github.com/dealii/dealii/pull/13804

#13803: Fix some miscellaneous typos. (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/13803

#13802: Avoid CellDataTransferBuffer in GridTools::exchange_cell_data_to_ghosts 
(proposed by kronbichler; merged) https://github.com/dealii/dealii/pull/13802

#13801: Avoid a second copy in Utilities::pack for vector arguments (proposed 
by kronbichler; merged) https://github.com/dealii/dealii/pull/13801

#13800: Slightly simplify setup of partitioners for global cell ids (proposed 
by kronbichler; merged) https://github.com/dealii/dealii/pull/13800

#13799: Fix compilation of Utilities::pack with std::vector (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/13799

#13798: Provide function to evaluate polynomial on array of positions (proposed 
by kronbichler; merged) https://github.com/dealii/dealii/pull/13798

#13797: Fix bug in FEEvaluation without vectorization (proposed by kronbichler; 
merged) https://github.com/dealii/dealii/pull/13797

#13796: Fix two tests with vectorization disabled (proposed by kronbichler; 
merged) https://github.com/dealii/dealii/pull/13796

#13795: Add some missing MPI boolean instantiations. (proposed by drwells; 
merged) https://github.com/dealii/dealii/pull/13795

#13793: Require SUNDIALS 5.4 or later. (proposed by drwells) 
https://github.com/dealii/dealii/pull/13793

#13792: PreconditionChebyshev: Implement power iteration for eigenvalue 
estimate (proposed by kronbichler; merged) 
https://github.com/dealii/dealii/pull/13792

#13791: Reduce cost to set up dictionary for compute_index_owner (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/13791

#13790: MatrixFree: Simplify initialization of ShapeInfo (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/13790

#13789: Clearify LA::d::BlockVector::reinit input argument (proposed by gfcas; 
merged) https://github.com/dealii/dealii/pull/13789

#13788: Kinsol sundials 6 (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/13788

#13787: Massively lower some IDA solver tolerances. (proposed by drwells) 
https://github.com/dealii/dealii/pull/13787

#13786: Fix ARKODE for SUNDIALS 6. (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/13786

#13785: Add an exception for commits from dependabot. (proposed by drwells; 
merged) https://github.com/dealii/dealii/pull/13785

#13784: Optimize pack()/unpack() for std::vector with trivially copyable T. 
(proposed by bangerth; merged) https://github.com/dealii/dealii/pull/13784

#13783: TBB oneAPI: make global_control object static (proposed by tamiko; 
merged) 

[deal.II] deal.II Newsletter #212

2022-05-17 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

#13749: Rename an exception (proposed by simonsticko; merged) 
https://github.com/dealii/dealii/pull/13749

#13748: Assert that the incoming cell is Cartesian in MappingCartesian 
(proposed by simonsticko; merged) https://github.com/dealii/dealii/pull/13748

#13747: Step-75: use well-formed deleter (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/13747

#13746: base/tensor.h: Fix a typo (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/13746

#13745: Avoid doing extra TLS lookups in FunctionParser. (proposed by drwells) 
https://github.com/dealii/dealii/pull/13745

#13744: TransfiniteInterpolationManifold: fix codimension one case (proposed by 
tamiko; merged) https://github.com/dealii/dealii/pull/13744

#13743: Cgal dealii tria from implicit function (proposed by luca-heltai) 
https://github.com/dealii/dealii/pull/13743

#13742: Fix a typo. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/13742

#13741: Fix sundials 6 tests, part 1 (proposed by drwells) 
https://github.com/dealii/dealii/pull/13741

#13739: Added missing headers to failing test. (proposed by marcfehling; 
merged) https://github.com/dealii/dealii/pull/13739

#13738: Fix typo w_cycle (proposed by gfcas; merged) 
https://github.com/dealii/dealii/pull/13738

#13737: LA:d:V: fix size in the case of shared memory (proposed by peterrum; 
merged) https://github.com/dealii/dealii/pull/13737

#13736: Fix some GCC-12 warnings. (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/13736

#13735: CGAL C3T3 to deal.II Triangulation. (proposed by luca-heltai) 
https://github.com/dealii/dealii/pull/13735

#13733: Avoid double packing/unpacking for CA algorithms. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/13733

#13732: CMake: remove -Wl,--as-needed flag setup (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/13732

#13731: Simplify the type used by ConsensusAlgorithm in 
compute_n_point_to_point_communications(). (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/13731

#13730: Add another variant for multigrid test (proposed by kronbichler; 
merged) https://github.com/dealii/dealii/pull/13730

#13729: Set is_tensor_product_flag in Quadrature::initialize(..) (proposed by 
simonsticko; merged) https://github.com/dealii/dealii/pull/13729

#13728: New test for MatrixFree::reinit with empty procs (proposed by 
sebproell; merged) https://github.com/dealii/dealii/pull/13728

#13726: CMake: Do not warn about not finding CGAL (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/13726

#13725: MF: fix if all cells of a process are FE_Nothing (proposed by peterrum; 
merged) https://github.com/dealii/dealii/pull/13725

#13724: Choose common SFINAE detection path for PreconditionChebyshev (proposed 
by kronbichler; merged) https://github.com/dealii/dealii/pull/13724

#13723: Fix three bugs in interleaved CG method (proposed by kronbichler; 
merged) https://github.com/dealii/dealii/pull/13723

#13722: Replace std::vector by RequestType in consensus 
algorithms. Same for AnswerType. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/13722

#13721: step-40: update IO section (proposed by tjhei) 
https://github.com/dealii/dealii/pull/13721

#13720: Rename the template type arguments of the consensus algorithms. 
(proposed by bangerth; merged) https://github.com/dealii/dealii/pull/13720

#13719: Clean up delete_duplicated_vertices() a little. (proposed by drwells; 
merged) https://github.com/dealii/dealii/pull/13719

#13718: Fix master face_no (proposed by bergbauer; merged) 
https://github.com/dealii/dealii/pull/13718

#13717: Corefine and compute boolean operations in CGAL (proposed by fdrmrc; 
merged) https://github.com/dealii/dealii/pull/13717

#13716: Adjust changelog for 64bit nonzeros. (proposed by marcfehling; merged) 
https://github.com/dealii/dealii/pull/13716

#13714: Fix test simplex/step-55. (proposed by marcfehling; merged) 
https://github.com/dealii/dealii/pull/13714

#13712: Restrict permissions for GITHUB_TOKEN. (proposed by marcfehling; 
merged) https://github.com/dealii/dealii/pull/13712

#13711: Fix the nodal renumbering tests. (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/13711

#13705: Create coarse mesh out of a CGAL::Surface_mesh (proposed by fdrmrc; 
merged) https://github.com/dealii/dealii/pull/13705

#13698: Add a data-locality-optimized iteration scheme to SolverCG (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/13698

#13694: Generalize do_interpolate_boundary_values() for pyramid and wedge 
(proposed by peterrum; merged) https://github.com/dealii/dealii/pull/13694

#13637: Introduce 

[deal.II] deal.II Newsletter #211

2022-05-10 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

#13711: Fix the nodal renumbering tests. (proposed by drwells) 
https://github.com/dealii/dealii/pull/13711

#13710: Restrict feinterface/stokes test (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/13710

#13709: Add two asserts in NonMatching::MeshClassifier. (proposed by 
simonsticko; merged) https://github.com/dealii/dealii/pull/13709

#13708: Add white space to fix exception message split over several lines. 
(proposed by simonsticko; merged) https://github.com/dealii/dealii/pull/13708

#13707: Add more tests. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/13707

#13706: Add ReferenceCell::get_midpoint_quadrature(). (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/13706

#13705: Create coarse mesh out of a CGAL::Surface_mesh (proposed by fdrmrc) 
https://github.com/dealii/dealii/pull/13705

#13704: SolverFlexibleCG: Slightly improve documentation (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/13704

#13702: Adjust test output for new FE_RaviartThomasNodal (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/13702

#13701: Fix test failure: Close the right AffineConstraints object (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/13701

#13700: Correctly size CellData::vertices in GridTools. (proposed by drwells; 
merged) https://github.com/dealii/dealii/pull/13700

#13699: Skip default values in get_coarse_mesh_description(). (proposed by 
drwells; merged) https://github.com/dealii/dealii/pull/13699

#13698: Add a data-locality-optimized iteration scheme to SolverCG (proposed by 
kronbichler) https://github.com/dealii/dealii/pull/13698

#13697: Add changelog for MappingQ (proposed by kronbichler; merged) 
https://github.com/dealii/dealii/pull/13697

#13696: Add GenericDoFsPerObject::generate() (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/13696

#13695: Fix format of table (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/13695

#13694: Generalize do_interpolate_boundary_values() for pyramid and wedge 
(proposed by peterrum) https://github.com/dealii/dealii/pull/13694

#13693: unit_support_points and unit_face_support_points for wedges and 
pyramids (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/13693

#13692: Implement ReferenceCell::face_to_cell_lines() for pyramids and wedges 
(proposed by peterrum; merged) https://github.com/dealii/dealii/pull/13692

#13691: Rename some face batches (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/13691

#13690: Improve asserts in MF/FEEval regarding FENothing (proposed by peterrum; 
merged) https://github.com/dealii/dealii/pull/13690

#13689: Test that exposes bug in Triangulation::create_triangulation (proposed 
by luca-heltai) https://github.com/dealii/dealii/pull/13689

#13688: Fix FEEvaluation::gather_evaluate() for user-defined batches (proposed 
by peterrum; merged) https://github.com/dealii/dealii/pull/13688

#13685: Reduce number of instantiations of FEEvaluation template factory 
(proposed by kronbichler; merged) https://github.com/dealii/dealii/pull/13685

#13684: Fix a recently added test (proposed by kronbichler; merged) 
https://github.com/dealii/dealii/pull/13684

#13683: Implement flexible variant of conjugate gradient method (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/13683

#13682: SolverCG: Switch to more common variable names (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/13682

#13681: Add LinearAlgebra::distributed::BlockVector::set_ghost_state() 
(proposed by peterrum; merged) https://github.com/dealii/dealii/pull/13681

#13679: Fix tests. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/13679

#13678: Add ReferenceCell::volume() and ::barycenter(). (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/13678

#13677: Petsc bddc preconditioner (proposed by nabw) 
https://github.com/dealii/dealii/pull/13677

#13676: Use simpler initialization of std::set (proposed by kronbichler; 
merged) https://github.com/dealii/dealii/pull/13676

#13675: Minor edits to the C++ namespace documentation. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/13675

#13674: Use renumbering of DoFs for step-37 benchmark (proposed by kronbichler; 
merged) https://github.com/dealii/dealii/pull/13674

#13673: Upgrade write_vtu_in_parallel based on mpi large IO update (proposed by 
pengfej) https://github.com/dealii/dealii/pull/13673

#13672: Improve tutorial graph (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/13672

#13671: Hanging nodes support for matrix-free RT (proposed by NiklasWik) 

[deal.II] deal.II Newsletter #210

2022-05-03 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

#13664: Cgal surface to deal.II triangulation (proposed by fdrmrc) 
https://github.com/dealii/dealii/pull/13664

#13663: MGConstrainedDoFs::add_boundary_indices() (proposed by zjiaqi2018) 
https://github.com/dealii/dealii/pull/13663

#13661: Cgal triangulation (proposed by luca-heltai) 
https://github.com/dealii/dealii/pull/13661

#13660: Fesystem indexing (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/13660

#13659: Silence warnings from Sacado in user projects. (proposed by drwells; 
merged) https://github.com/dealii/dealii/pull/13659

#13658: Assert that a method was choosen in the time stepping methods. 
(proposed by simonsticko; merged) https://github.com/dealii/dealii/pull/13658

#13657: Add class NonMatching::FEInterfaceValues (proposed by simonsticko) 
https://github.com/dealii/dealii/pull/13657

#13656: Cleanup artifacts (proposed by luca-heltai) 
https://github.com/dealii/dealii/pull/13656

#13655: Update documentation in DataOutFaces. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/13655

#13654: Ghost particle property pool breakage (proposed by gassmoeller; merged) 
https://github.com/dealii/dealii/pull/13654

#13653: Add CGAL::Surface_mesh support (proposed by fdrmrc) 
https://github.com/dealii/dealii/pull/13653

#13652: Instantiate make_periodicity_constraints for all scalar numbers 
(proposed by kronbichler; merged) https://github.com/dealii/dealii/pull/13652

#13651: Add float instanciations to `DoFTools::make_periodicity_constraints` 
(proposed by NiklasWik) https://github.com/dealii/dealii/pull/13651

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

#13648: Add DataPostprocessors::BoundaryIds. (proposed by bangerth) 
https://github.com/dealii/dealii/pull/13648

#13647: Add function to simplex docs. (proposed by luca-heltai; merged) 
https://github.com/dealii/dealii/pull/13647

#13646: Add simple test that breaks property pool in debug (proposed by blaisb) 
https://github.com/dealii/dealii/pull/13646

#13645: step-44: Change the FE space used for p,J (proposed by jppelteret; 
merged) https://github.com/dealii/dealii/pull/13645

#13644: Added support for CGAL library. (proposed by luca-heltai; merged) 
https://github.com/dealii/dealii/pull/13644

#13628:  Add a new renumbering function for data locality with MatrixFree 
(proposed by kronbichler; merged) https://github.com/dealii/dealii/pull/13628

#13627: Glossary edit for material ids (proposed by singima; merged) 
https://github.com/dealii/dealii/pull/13627

#13625: Add enable_abort_on_exception (proposed by elauksap; merged) 
https://github.com/dealii/dealii/pull/13625

#13593: Installation problem with MPI on Windows (proposed by DaneilSun; 
merged) https://github.com/dealii/dealii/pull/13593

#13564: Provide a count_cycles() function. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/13564

#13543: remove notes on indentation from documentation (proposed by nfehn; 
merged) https://github.com/dealii/dealii/pull/13543


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

#13662: Redundant template parameter for MGSmoother (opened) 
https://github.com/dealii/dealii/issues/13662

#13649: Failing test with bundled BOOST (opened and closed) 
https://github.com/dealii/dealii/issues/13649

#13643: A bug in particles class (closed) 
https://github.com/dealii/dealii/issues/13643

#13531: Why does "coding conventions" contain information on "indentation"? 
(closed) https://github.com/dealii/dealii/issues/13531

#11612: Step-44: Use FE_DGP instead of FE_DGPMonomial? (closed) 
https://github.com/dealii/dealii/issues/11612


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/627151a2.1c69fb81.9f0a.1452SMTPIN_ADDED_MISSING%40gmr-mx.google.com.


[deal.II] deal.II Newsletter #209

2022-04-26 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

#13642: Matrix-free Piola transformation for affine cells (proposed by 
NiklasWik) https://github.com/dealii/dealii/pull/13642

#13641: Implement MGLevelObject::back() (proposed by peterrum) 
https://github.com/dealii/dealii/pull/13641

#13637: Introduce MGTransferBlockGlobalCoarsening (proposed by peterrum) 
https://github.com/dealii/dealii/pull/13637

#13636: Simplify MGTransferBlockMatrixFreeBase::copy_to_mg() (proposed by 
peterrum) https://github.com/dealii/dealii/pull/13636

#13635: [WIP] Use p:d:T::find_point_owner_rank() in GridTools (proposed by 
peterrum) https://github.com/dealii/dealii/pull/13635

#13634: Remove parameter use_fast_hanging_node_algorithm from MF (proposed by 
peterrum; merged) https://github.com/dealii/dealii/pull/13634

#13633: Write DEAL_II_SOURCE_DIR to Config.cmake (proposed by peterrum) 
https://github.com/dealii/dealii/pull/13633

#13632: Change cell type passed to DiscreteQuadratureGenerator::generate() 
(proposed by simonsticko; merged) https://github.com/dealii/dealii/pull/13632

#13631: Fixes CMake version > 3.12 python-binding build failure (proposed by 
CorbinFoucart) https://github.com/dealii/dealii/pull/13631

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

#13629: Fix typo in variable name (proposed by kronbichler; merged) 
https://github.com/dealii/dealii/pull/13629

#13628:  Add a new renumbering function for data locality with MatrixFree 
(proposed by kronbichler) https://github.com/dealii/dealii/pull/13628

#13627: Glossary edit for material ids (proposed by singima) 
https://github.com/dealii/dealii/pull/13627

#13626: Changes to XDMFEntry to use uint64_t data types (proposed by singima; 
merged) https://github.com/dealii/dealii/pull/13626

#13625: Add enable_abort_on_exception (proposed by elauksap) 
https://github.com/dealii/dealii/pull/13625

#13624: fixing typo of the type 'the the' (proposed by cdev911; merged) 
https://github.com/dealii/dealii/pull/13624

#13617: Using uint64_t as node variables for hdf5 output (proposed by singima; 
merged) https://github.com/dealii/dealii/pull/13617

#13615: Quadrature generator with discrete levelset (proposed by bergbauer; 
merged) https://github.com/dealii/dealii/pull/13615

#13610: FEInterfaceValues::get_jump/average_*_function_values (proposed by 
zjiaqi2018; merged) https://github.com/dealii/dealii/pull/13610

#13573: Add functions to MGTools (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/13573

#13341: Add iota views to FEEval (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/13341


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

#13643: A bug in particles class (opened) 
https://github.com/dealii/dealii/issues/13643

#13640: Deprecated boost header (opened) 
https://github.com/dealii/dealii/issues/13640

#13639: build fail on riscv64 arch (opened) 
https://github.com/dealii/dealii/issues/13639

#13638: hdf5 tests fail (opened) https://github.com/dealii/dealii/issues/13638

#12780: Reevaluate MF::AdditionalData::use_fast_hanging_node_algorithm (closed) 
https://github.com/dealii/dealii/issues/12780

#11206: Brainstorming - Re-design the data storage structure used in the 
ParticleHandler (closed) https://github.com/dealii/dealii/issues/11206

#10928: Interfaces to `FEEvaluationImpl` & co (closed) 
https://github.com/dealii/dealii/issues/10928


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/62681739.1c69fb81.43465.245bSMTPIN_ADDED_MISSING%40gmr-mx.google.com.


[deal.II] deal.II Newsletter #208

2022-04-19 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

#13624: fixing typo of the type 'the the' (proposed by cdev911) 
https://github.com/dealii/dealii/pull/13624

#13621: Make DoFRenumbering::support_point_wise() about twice as fast. 
(proposed by drwells; merged) https://github.com/dealii/dealii/pull/13621

#13620: Update step-71.cc (proposed by cdev911) 
https://github.com/dealii/dealii/pull/13620

#13617: Using uint64_t as node variables for hdf5 output (proposed by singima) 
https://github.com/dealii/dealii/pull/13617

#13616: Discrete level let for quadrature generator (proposed by bergbauer) 
https://github.com/dealii/dealii/pull/13616

#13615: Draft: Quadrature generator with discrete levelset (proposed by 
bergbauer) https://github.com/dealii/dealii/pull/13615

#13614: fix bug in Assert() macro (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/13614

#13612: fix a release mode warning (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/13612

#13611: embed BigMPICompat library (proposed by tjhei) 
https://github.com/dealii/dealii/pull/13611

#13608: Introduce MGTransferBlockMatrixFreeBase (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/13608

#13605: Generalize IsBlockVector (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/13605

#13604: RPE: refactor determination of unique mapping and all points found 
(proposed by peterrum; merged) https://github.com/dealii/dealii/pull/13604

#13581: Update bundled muParser to 2.3.3 (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/13581


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

#13623: Triangulation::has_hanging_nodes() logic is wrong in case of 
anisotropic refinement (opened) https://github.com/dealii/dealii/issues/13623

#13622: Resolution of identity constraints during 
FEEvaluation::read_dof_values_plain() (opened) 
https://github.com/dealii/dealii/issues/13622

#13619: How to visualize .vtu files from step-79? What software would be 
suitable? (opened and closed) https://github.com/dealii/dealii/issues/13619

#13618: Autodifferentiable numbers with the `SymmetricTensor` `eigenvectors` 
method fails for some number of zero entries (opened) 
https://github.com/dealii/dealii/issues/13618

#12986: Big MPI data type test fails (closed) 
https://github.com/dealii/dealii/issues/12986


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/625edcc3.1c69fb81.6da8a.72fdSMTPIN_ADDED_MISSING%40gmr-mx.google.com.


[deal.II] deal.II Newsletter #207

2022-04-12 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

#13610: FEInterfaceViews::get_jump/average_*_function_values (proposed by 
zjiaqi2018) https://github.com/dealii/dealii/pull/13610

#13609: Added Zenodo DOI for step-75. (proposed by marcfehling; merged) 
https://github.com/dealii/dealii/pull/13609

#13608: Introduce MGTransferBlockMatrixFreeBase (proposed by peterrum) 
https://github.com/dealii/dealii/pull/13608

#13607: Test LA::d::V's shared-memory capability on a Cartesian virtual 
topology (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/13607

#13606: Simplify check for BlockVector (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/13606

#13605: Generalize IsBlockVector (proposed by peterrum) 
https://github.com/dealii/dealii/pull/13605

#13604: RPE: refactor determination of unique mapping and all points found 
(proposed by peterrum) https://github.com/dealii/dealii/pull/13604

#13603: Fix MGTransferGlobalCoarsening::interpolate_to_mg() (proposed by 
peterrum; merged) https://github.com/dealii/dealii/pull/13603

#13601: bug in RemotePointEvaluation::point_found(i) for i=0 (proposed by 
nfehn; merged) https://github.com/dealii/dealii/pull/13601

#13600: Define Quadrature<0>::SubQuadrature as Quadrature<0> (proposed by 
simonsticko; merged) https://github.com/dealii/dealii/pull/13600

#13599: [WIP] Use 64-bit integer for `n_nonzero_elements`. (proposed by 
marcfehling) https://github.com/dealii/dealii/pull/13599

#13598: [WIP] Use Trilinos' int_type in wrapper classes. (proposed by 
marcfehling) https://github.com/dealii/dealii/pull/13598

#13597: Specialize NonMatching::FaceQuadratureGenerator in 1D (proposed by 
simonsticko; merged) https://github.com/dealii/dealii/pull/13597

#13594: Update link to wiki in `indent_common.sh`. (proposed by marcfehling; 
merged) https://github.com/dealii/dealii/pull/13594


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

#13602: Improve docu of RPE::get_point_ptrs() (opened) 
https://github.com/dealii/dealii/issues/13602

#13596: Extend github workers for `MSVC`. (opened) 
https://github.com/dealii/dealii/issues/13596

#13595: Introduce `types::fe_index`. (opened) 
https://github.com/dealii/dealii/issues/13595


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/6255a21d.1c69fb81.def48.43c1SMTPIN_ADDED_MISSING%40gmr-mx.google.com.


[deal.II] deal.II Newsletter #206

2022-04-05 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

#13593: Installation problem with MPI on Windows (proposed by DaneilSun) 
https://github.com/dealii/dealii/pull/13593

#13592:  Installation problem with MPI on Windows (proposed by DaneilSun) 
https://github.com/dealii/dealii/pull/13592

#13591: Matrixfree evaluation with `FE_RaviartThomasNodal` (proposed by 
NiklasWik) https://github.com/dealii/dealii/pull/13591

#13590: Add gradient and estimate for hessian to SignedDistance::Ellipsoid 
(proposed by bergbauer) https://github.com/dealii/dealii/pull/13590

#13589: LA::d::V:reinit() add check (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/13589

#13587: Provide a proper reference. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/13587

#13586: Bug fix - renumbering points for FERaviartThomasNodal (proposed by 
NiklasWik; merged) https://github.com/dealii/dealii/pull/13586

#13585: Bug fix - renumber anisotropic points for FE_RaviartThomasNodal 
(proposed by NiklasWik) https://github.com/dealii/dealii/pull/13585

#13583: Minor updates to DataOutFilter. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/13583

#13582: Update the documentation of GridTools::cell_measure(). (proposed by 
drwells; merged) https://github.com/dealii/dealii/pull/13582

#13581: Update bundled muParser to 2.3.3 (proposed by drwells) 
https://github.com/dealii/dealii/pull/13581

#13579: Allow loading triangular meshes from Gmsh with some cells inverted 
(proposed by zjiaqi2018; merged) https://github.com/dealii/dealii/pull/13579

#13565: Add wrappers for ArborX::Sphere (proposed by Rombur; merged) 
https://github.com/dealii/dealii/pull/13565

#13547: Add RPE::all_points_found() and ::point_found() (proposed by peterrum; 
merged) https://github.com/dealii/dealii/pull/13547

#13536: Nodal renumbering (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/13536


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

#13588: I want to develop a spectral element code based on the dealii, what is 
your suggestions? (opened and closed) 
https://github.com/dealii/dealii/issues/13588

#13584: Get rid of std::abs() when computing tet volumes (opened) 
https://github.com/dealii/dealii/issues/13584

#13501: Robustness problem with RemotePointEvaluation (closed) 
https://github.com/dealii/dealii/issues/13501


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/624c6798.1c69fb81.58159.a712SMTPIN_ADDED_MISSING%40gmr-mx.google.com.


[deal.II] deal.II Newsletter #205

2022-03-28 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

#13579: Allow loading triangular meshes from Gmsh with some cells inverted 
(proposed by zjiaqi2018) https://github.com/dealii/dealii/pull/13579

#13577: Use PIMPL in our muParser implementation. (proposed by drwells) 
https://github.com/dealii/dealii/pull/13577

#13576: Run one parallel hp unification test with three and four processes. 
(proposed by marcfehling; merged) https://github.com/dealii/dealii/pull/13576

#13573: Add functions to MGTools (proposed by peterrum) 
https://github.com/dealii/dealii/pull/13573

#13572: cell_weight: add changelog for bugfix. (proposed by marcfehling; 
merged) https://github.com/dealii/dealii/pull/13572

#13571: Avoid a copy of a vector. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/13571

#13570: Simplify code using BOOST::variant. (proposed by bangerth) 
https://github.com/dealii/dealii/pull/13570

#13569: MappingQ: add public member function get_mapping_support_points() 
(proposed by nfehn) https://github.com/dealii/dealii/pull/13569

#13567: Make DoFRenumbering work when some processors have 0 DoFs. (proposed by 
drwells; merged) https://github.com/dealii/dealii/pull/13567

#13566: Use compressed_constraint_kind in MatrixFree (CPU) (proposed by 
peterrum; merged) https://github.com/dealii/dealii/pull/13566

#13565: Add wrappers for ArborX::Sphere (proposed by Rombur) 
https://github.com/dealii/dealii/pull/13565

#13564: Provide a count_cycles() function. (proposed by bangerth) 
https://github.com/dealii/dealii/pull/13564

#13563: Simplify a piece of code. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/13563

#13562: Avoid one use of GeometryInfo. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/13562

#13561: cell_weight: suggestions from code review. (proposed by marcfehling; 
merged) https://github.com/dealii/dealii/pull/13561

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

#13559: Minor particle cleanups. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/13559

#13558: Minor cleanups. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/13558

#13557: GC: compressed weights -> AlignedVector (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/13557

#13556: Rename a class. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/13556

#13554: CMake: uniformly require version 3.3.0 (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/13554

#13553: Version number update: deal.II -> 9.4.0-pre (proposed by tamiko; 
merged) https://github.com/dealii/dealii/pull/13553

#13552: ConstraintKinds: compress/decompress (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/13552

#13551: GC::create_geometric_coarsening_sequence() add assert (proposed by 
peterrum; merged) https://github.com/dealii/dealii/pull/13551

#13550: GC: test FE_DGQ(0) (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/13550

#13549: Add Kokkos backend (proposed by masterleinad) 
https://github.com/dealii/dealii/pull/13549

#13548: Fix docu of PreconditionChebyshev regarding degree (proposed by 
peterrum; merged) https://github.com/dealii/dealii/pull/13548

#13541: Add ScalarType as template parameter to MeshWorker::CopyData (proposed 
by jppelteret; merged) https://github.com/dealii/dealii/pull/13541

#13538: Fix test for nearest query for ArborXWrappers::DistributedTree 
(proposed by Rombur; merged) https://github.com/dealii/dealii/pull/13538

#13451: cell_weight: remove initial weight from distributed applications. 
(proposed by marcfehling; merged) https://github.com/dealii/dealii/pull/13451


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

#13580: `VectorTools::Interpolate()` gives different results for `RE_DGQ` and 
`FE_RaviartThomasNodal` (opened) https://github.com/dealii/dealii/issues/13580

#13578: TLS is quite slow (opened) https://github.com/dealii/dealii/issues/13578

#13575: New website (opened) https://github.com/dealii/dealii/issues/13575

#13574: deal.II Release 9.4 - deadline June 10 (opened) 
https://github.com/dealii/dealii/issues/13574

#13568: Mapping::get_vertices() uses GeometryInfo::vertices_per_cell (opened) 
https://github.com/dealii/dealii/issues/13568

#13555: For load balancing, should weights of cells be of type `double`? 
(opened) https://github.com/dealii/dealii/issues/13555

#13532: Shift "coding conventions" to Wiki? (closed) 
https://github.com/dealii/dealii/issues/13532

#13510: For load balancing, should cells have a "base weight" or not? (closed) 
https://github.com/dealii/dealii/issues/13510


A list of all major changes since the last release can be found at 

[deal.II] deal.II Newsletter #204

2022-03-17 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

#13548: Fix docu of PreconditionChebyshev regarding degree (proposed by 
peterrum) https://github.com/dealii/dealii/pull/13548

#13547: Add RPE::all_points_found() and ::valid_point_masks() (proposed by 
peterrum) https://github.com/dealii/dealii/pull/13547

#13546: Add Multigrid::set_edge_in_matrix() (proposed by peterrum) 
https://github.com/dealii/dealii/pull/13546

#13545: Make doxygen show correct header file for GridTools::Cache (proposed by 
masterleinad; merged) https://github.com/dealii/dealii/pull/13545

#13543: remove notes on indentation from documentation (proposed by nfehn) 
https://github.com/dealii/dealii/pull/13543

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

#13541: Add ScalarType as template parameter to MeshWorker::CopyData (proposed 
by jppelteret) https://github.com/dealii/dealii/pull/13541

#13540: Add asserts to MGTwoLevelTransfer (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/13540

#13539: MGTransferGlobalCoarsening::initialize_dof_vector() skip zeroing 
(proposed by peterrum; merged) https://github.com/dealii/dealii/pull/13539

#13538: Fix test for nearest query for ArborXWrappers::DistributedTree 
(proposed by Rombur) https://github.com/dealii/dealii/pull/13538

#13537: Add type promotion to vectorization math operations (proposed by 
jppelteret) https://github.com/dealii/dealii/pull/13537

#13536: Nodal renumbering (proposed by drwells) 
https://github.com/dealii/dealii/pull/13536

#13535: Change one GitHub Workflow CI check to use C++20 (proposed by 
masterleinad) https://github.com/dealii/dealii/pull/13535

#13534: Fix typo in issue_template.md (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/13534

#13533: MGTwoLevelTransfer: remove fine-vector specialization for DG (proposed 
by peterrum; merged) https://github.com/dealii/dealii/pull/13533

#13530: Introduce DEAL_II_VERSION_LTE (proposed by peterrum) 
https://github.com/dealii/dealii/pull/13530

#13529: Implement MGLevelObject::n_levels() (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/13529

#13528: Compute DoFInfo::hanging_node_constraint_masks_comp once (proposed by 
peterrum; merged) https://github.com/dealii/dealii/pull/13528

#13527: Reserve internal container with correct size. (proposed by marcfehling; 
merged) https://github.com/dealii/dealii/pull/13527

#13526: Enable `sc_init` again. (proposed by marcfehling; merged) 
https://github.com/dealii/dealii/pull/13526

#13525: Refine MGTwoLevelTransfer::enable_inplace_operations_if_possible() 
(proposed by peterrum; merged) https://github.com/dealii/dealii/pull/13525

#13524: MatrixFree: fix typo assert message (proposed by mschreter; merged) 
https://github.com/dealii/dealii/pull/13524

#13523: update changelog entry (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/13523

#13521: Revert most of "Avoid implicit bool conversions" (proposed by drwells) 
https://github.com/dealii/dealii/pull/13521

#13520: Refactor constraint application of MGTwoLevelTransfer (proposed by 
peterrum; merged) https://github.com/dealii/dealii/pull/13520

#13519: Introduce internal::MatrixFreeFunctions::ConstraintInfo (proposed by 
peterrum; merged) https://github.com/dealii/dealii/pull/13519

#13518: Remove specialization in MGTwoLevelTransfer::interpolate() (proposed by 
peterrum; merged) https://github.com/dealii/dealii/pull/13518

#13515: Minor updates to the constant modes documentation. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/13515

#13514: Specifying material IDs on Gmsh imports (proposed by singima; merged) 
https://github.com/dealii/dealii/pull/13514

#13513: Test extract constant modes 04 (proposed by gfcas) 
https://github.com/dealii/dealii/pull/13513

#13512: Update constant_modes doc (proposed by gfcas) 
https://github.com/dealii/dealii/pull/13512

#13511: Removed outdated comment. (proposed by marcfehling; merged) 
https://github.com/dealii/dealii/pull/13511

#13508: GitHub-CI: test CPP17 (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/13508

#13507: Use get_communicator() (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/13507

#13506: Check during MF::reinit() if AffineConstraints are closed (proposed by 
peterrum; merged) https://github.com/dealii/dealii/pull/13506

#13505: Add AffineConstraints::is_closed() (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/13505

#13504: Remove a note. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/13504

#13503: Fix std_cxx17::get (proposed by peterrum) 
https://github.com/dealii/dealii/pull/13503

#13502: boost::get -> std_cxx17::get (proposed by masterleinad; merged) 

[deal.II] deal.II Newsletter #203

2022-03-02 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

#13482: Deprecate Utilities::MPI::create_group (proposed by masterleinad) 
https://github.com/dealii/dealii/pull/13482

#13481: clarify docu of MatrixFree::initialize_dof_vector() (proposed by nfehn) 
https://github.com/dealii/dealii/pull/13481

#13479: Simplify logic in RepartitioningPolicyTools::FirstChildPolicy (proposed 
by peterrum) https://github.com/dealii/dealii/pull/13479

#13478: Move p:d:T::has_hanging_nodes() to DistributedTriangulationBase 
(proposed by peterrum) https://github.com/dealii/dealii/pull/13478

#13476: Avoid integer comparison warning. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/13476

#13473: Provide a template variable that can be used to query whether T is a 
natively supported MPI type. (proposed by bangerth) 
https://github.com/dealii/dealii/pull/13473

#13472: Deal gracefully with replicating an empty array. (proposed by bangerth) 
https://github.com/dealii/dealii/pull/13472

#13471: Use a valid communicator. (proposed by bangerth) 
https://github.com/dealii/dealii/pull/13471

#13470: Check MPI error codes. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/13470

#13468: quick_tests/affinity: fix warning (proposed by marcfehling) 
https://github.com/dealii/dealii/pull/13468

#13467: Run quick tests in GitHub Linux CI (proposed by masterleinad) 
https://github.com/dealii/dealii/pull/13467

#13466: Fix the TBB quick test. (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/13466

#13465: Remove MPI 2.x logic (proposed by pengfej) 
https://github.com/dealii/dealii/pull/13465

#13464: documentation: MPI 3.0 minimum (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/13464

#13463: Minor update to FE_Nedelec. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/13463

#13462: add changelog entry (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/13462

#13461: CMake: require MPI 3.0 (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/13461

#13459: Fix GC tests (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/13459

#13458: [CI] run all MPI tests on Jenkins (proposed by tjhei) 
https://github.com/dealii/dealii/pull/13458

#13457: Improve asserts in parallel::distributed::SolutionTransfer (proposed by 
peterrum) https://github.com/dealii/dealii/pull/13457

#13455: add test for invert_cells_with_negative_measure (proposed by tjhei; 
merged) https://github.com/dealii/dealii/pull/13455

#13454: add changelog for gmsh inverted cell fix (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/13454

#13453: Avoid a warning about comparison of differently sized integers. 
(proposed by bangerth; merged) https://github.com/dealii/dealii/pull/13453

#13452: Provide a second error for Trilinos sparsity pattern problems. 
(proposed by bangerth; merged) https://github.com/dealii/dealii/pull/13452

#13451: cell_weight: remove initial weight from distributed applications. 
(proposed by marcfehling) https://github.com/dealii/dealii/pull/13451

#13450: Fix instantiation for add_entries_local_to_global (proposed by 
zjiaqi2018; merged) https://github.com/dealii/dealii/pull/13450

#13449: cell_weight: not implemented for partition_zorder (proposed by 
marcfehling; merged) https://github.com/dealii/dealii/pull/13449

#13448: Add an assertion for p4est weights. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/13448

#13446: Simplify MPI IO in parallel vtu output (proposed by pengfej; merged) 
https://github.com/dealii/dealii/pull/13446

#13445: Error out with too large Trilinos sparsity patterns. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/13445

#13444: Allow loading Gmsh files with some cells inverted (proposed by singima; 
merged) https://github.com/dealii/dealii/pull/13444

#13443: Add assert to MFTools::compute_diagonal() (proposed by peterrum; 
merged) https://github.com/dealii/dealii/pull/13443

#13442: Minor updates to ARKode in-code commentary. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/13442

#13441: Fix run time error in step-75: initialize diagonal vector (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/13441

#13439: Declare a number of static consts as constexpr (proposed by tamiko; 
merged) https://github.com/dealii/dealii/pull/13439

#13438: Support SUNDIALS 6.0 and later. (proposed by bangerth) 
https://github.com/dealii/dealii/pull/13438

#13437: Replace present_index by index() in DoFAccessor (proposed by 
rezarastak; merged) https://github.com/dealii/dealii/pull/13437

#13436: Move a couple of functions out of line. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/13436

#13427: Add 

[deal.II] deal.II Newsletter #202

2022-02-22 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

#13436: Move a couple of functions out of line. (proposed by bangerth) 
https://github.com/dealii/dealii/pull/13436

#13435: Fixed ParsedConvergenceTable::difference() (proposed by luca-heltai) 
https://github.com/dealii/dealii/pull/13435

#13434: Fix p:d:T::copy_triangulation() (proposed by peterrum) 
https://github.com/dealii/dealii/pull/13434

#13433: New DoFAccessor test added for vertex dofs (proposed by rezarastak) 
https://github.com/dealii/dealii/pull/13433

#13432: change logic in tensor product kernels to positive statements? 
(proposed by nfehn) https://github.com/dealii/dealii/pull/13432

#13431: Fix indent-all header typo (proposed by gfcas; merged) 
https://github.com/dealii/dealii/pull/13431

#13430: Improve assert message for invalid FE indices in DoFAccessor (proposed 
by peterrum; merged) https://github.com/dealii/dealii/pull/13430

#13429: Replace present_index by index() in DoFAccessor (proposed by peterrum; 
merged) https://github.com/dealii/dealii/pull/13429

#13427: Add shape function illustrations for FE_Nedelec (proposed by harmonj) 
https://github.com/dealii/dealii/pull/13427

#13426: CMake: Fix typo (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/13426

#13425: Add erf function to deal.II muparser functions (proposed by blaisb; 
merged) https://github.com/dealii/dealii/pull/13425

#13424: Performance tests: some more polishing (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/13424

#13423: Bugfix: adjust collect_measurements to new directory layout (proposed 
by tamiko; merged) https://github.com/dealii/dealii/pull/13423

#13422: Remove some unnecessary includes of grid_tools.h (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/13422

#13421: Fixed bug in gmsh api. (proposed by luca-heltai; merged) 
https://github.com/dealii/dealii/pull/13421

#13420: FEEval::check_vector_compatibility: improve assert message (proposed by 
peterrum; merged) https://github.com/dealii/dealii/pull/13420

#13419: Utilities::MPI::internal::ComputeIndexOwner classes into a source file. 
(proposed by drwells; merged) https://github.com/dealii/dealii/pull/13419

#13417: CMake: Testsuite: make target names compatible with 9.3 (proposed by 
tamiko; merged) https://github.com/dealii/dealii/pull/13417

#13416: Fix non matching coupling (proposed by luca-heltai) 
https://github.com/dealii/dealii/pull/13416

#13415: Another rectangular version of add_entries_local_to_global() (proposed 
by luca-heltai; merged) https://github.com/dealii/dealii/pull/13415

#13414: Introduce free functions for consensus algorithms. (proposed by 
bangerth) https://github.com/dealii/dealii/pull/13414

#13413: CMake: Do not use "\." in CMake regular expression (proposed by tamiko; 
merged) https://github.com/dealii/dealii/pull/13413

#13410: Make hyper_ball_balanced available for 
GridGenerator::generate_from_name_and_argument() (proposed by luca-heltai; 
merged) https://github.com/dealii/dealii/pull/13410

#13409: Performance tests: add a valgrind wrapper (proposed by tamiko) 
https://github.com/dealii/dealii/pull/13409

#13408: CMake: also record git commit timestamp (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/13408

#13407: step-40/step-17 grammar edits (proposed by singima; merged) 
https://github.com/dealii/dealii/pull/13407

#13406: Improve indentation in a few tutorials (proposed by kronbichler; 
merged) https://github.com/dealii/dealii/pull/13406

#13405: Add matrix-free benchmark based on step-37 (proposed by kronbichler; 
merged) https://github.com/dealii/dealii/pull/13405

#13403: remove useless assert (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/13403

#13401: Harden cmake regexes when looking for #define strings. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/13401

#13400: Fix typo (proposed by kronbichler; merged) 
https://github.com/dealii/dealii/pull/13400

#13399: Improve instruction-level parallelism for precondition_SSOR (proposed 
by kronbichler; merged) https://github.com/dealii/dealii/pull/13399

#13398: Minor cleanup to test of non_matching::FEValues (proposed by 
simonsticko; merged) https://github.com/dealii/dealii/pull/13398

#13397: Add support in Patterns::Tools::Convert for std::array (proposed by 
luca-heltai; merged) https://github.com/dealii/dealii/pull/13397

#13396: LA::d::BV add copy_locally_owned_data_from() (proposed by peterrum; 
merged) https://github.com/dealii/dealii/pull/13396

#13395: Make mpi_type_id a template variable. (proposed by bangerth) 
https://github.com/dealii/dealii/pull/13395

#13394: Add ArborXWrappers::DistributedTree (proposed by Rombur) 
https://github.com/dealii/dealii/pull/13394

#13393: Explicitly delete a function 

[deal.II] deal.II Newsletter #201

2022-02-15 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

#13392: CMake: Simplify some logic in DEAL_II_ADD_TEST and add verbose error 
messages (proposed by tamiko) https://github.com/dealii/dealii/pull/13392

#13391: CMake: Testsuite: Actually submit test results (proposed by tamiko; 
merged) https://github.com/dealii/dealii/pull/13391

#13390: Overwrite LocationToLevelSet values with unassigned in MeshClassifier 
(proposed by simonsticko) https://github.com/dealii/dealii/pull/13390

#13389: Testsuite: add a test checking test.json + test.output support 
(proposed by tamiko) https://github.com/dealii/dealii/pull/13389

#13388: CMake: Allow to define multiple threads= variant tests (proposed by 
tamiko) https://github.com/dealii/dealii/pull/13388

#13387: CMake: Set ${CTEST_SITE} if unset (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/13387

#13386: CMake: Bugfix: Do not error out when not running performance tests 
(proposed by tamiko; merged) https://github.com/dealii/dealii/pull/13386

#13385: Improve an error message. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/13385

#13384: Avoid implicit-bool conversion for stream objects. (proposed by 
bangerth) https://github.com/dealii/dealii/pull/13384

#13382: Unify deal.II spelling (proposed by gfcas; merged) 
https://github.com/dealii/dealii/pull/13382

#13381: Simplify indent_common.sh (proposed by gfcas; merged) 
https://github.com/dealii/dealii/pull/13381

#13380: Indent scripts (proposed by gfcas; merged) 
https://github.com/dealii/dealii/pull/13380

#13379: support large buffers in MPI::broadcast() (proposed by tjhei) 
https://github.com/dealii/dealii/pull/13379

#13378: Changelog for #13363. (proposed by marcfehling; merged) 
https://github.com/dealii/dealii/pull/13378

#13376: Use the correct data type for a buffer size variable. (proposed by 
bangerth) https://github.com/dealii/dealii/pull/13376

#13375: Augment a doc string. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/13375

#13374: CMake: Adjust MPI and ZLIB support query for p4est version 2.8 
(proposed by tamiko) https://github.com/dealii/dealii/pull/13374

#13373: MatrixFreeTools: small clean up (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/13373

#13372: Performance tests: minor tweak for timing_step_22 (proposed by tamiko; 
merged) https://github.com/dealii/dealii/pull/13372

#13371: CMake: allow to use TEST_PICKUP_REGEX with run_performance_tests.cmake 
(proposed by tamiko; merged) https://github.com/dealii/dealii/pull/13371

#13370: BlockDynamicSparsityPattern: Update doc for parallel distributed 
applications. (proposed by marcfehling; merged) 
https://github.com/dealii/dealii/pull/13370

#13369: CMake: remove debug message (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/13369

#13368: new MPI:broadcast with big count support (proposed by tjhei) 
https://github.com/dealii/dealii/pull/13368

#13367: MPI: move mpi_type_id() out of internal (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/13367

#13366: MatrixFreeTools: add functions that take vector of FEEval (proposed by 
peterrum) https://github.com/dealii/dealii/pull/13366

#13365: Early deprecate functions in DoFTools (proposed by peterrum) 
https://github.com/dealii/dealii/pull/13365

#13364: Implement new Table<3, T>::reinit() (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/13364

#13363: step-55: init sparsity pattern with relevant dofs (proposed by 
marcfehling; merged) https://github.com/dealii/dealii/pull/13363

#13362: step-55: remove comment (proposed by marcfehling; merged) 
https://github.com/dealii/dealii/pull/13362

#13361: Do not free objects we still need. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/13361

#13360: Use standard spacing between functions. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/13360

#13356: Document macro DEAL_II_VERSION_GTE (proposed by nfehn; merged) 
https://github.com/dealii/dealii/pull/13356

#13355: Rename a variable. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/13355

#13354: Make a variable 'const'. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/13354

#13353: make GridGenerator::hyper_ball_balanced() work with nonzero origins. 
(proposed by drwells; merged) https://github.com/dealii/dealii/pull/13353

#13352: Add performance testing framework: low-level test driver (proposed by 
tamiko; merged) https://github.com/dealii/dealii/pull/13352

#13351: Add performance testing framework: implement .run_only keyword. 
(proposed by tamiko; merged) https://github.com/dealii/dealii/pull/13351

#13350: Add performance testing framework: preparatory refactoring (proposed by 
tamiko; 

[deal.II] deal.II Newsletter #200

2022-02-08 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

#13344: Fix boundary IDs for `pipe_junction`. (proposed by marcfehling; merged) 
https://github.com/dealii/dealii/pull/13344

#13343: Add MGSmootherPrecondition::initialize_matrices() (proposed by 
peterrum) https://github.com/dealii/dealii/pull/13343

#13342: Fix name of change-log entry (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/13342

#13341: Make FEEval more consistent with FEValues (proposed by peterrum) 
https://github.com/dealii/dealii/pull/13341

#13340: Fix assert message for empty vector (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/13340

#13339: Save a few cycles for single-character output. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/13339

#13338: correcting some notations (proposed by pengfej; merged) 
https://github.com/dealii/dealii/pull/13338

#13337: Fix deduction matrix free (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/13337

#13336: VTU: put closing XML on separate line (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/13336

#13335: SolverControl: make constructors explicit (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/13335

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

#1: PreconditionIdentity: move implementation out of declaration (proposed 
by tjhei; merged) https://github.com/dealii/dealii/pull/1

#13332: fix a formula (proposed by zjiaqi2018; merged) 
https://github.com/dealii/dealii/pull/13332

#13331: remove two wrong file comments (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/13331

#13330: remove forward declarations of MappingQ (proposed by nfehn; merged) 
https://github.com/dealii/dealii/pull/13330

#13328: Add MatrixFree::initialize_cell_data_vector()  (proposed by peterrum; 
merged) https://github.com/dealii/dealii/pull/13328

#13327: FEEval::reinit(std::array): use MappingDataOnTheFly (proposed by 
peterrum; merged) https://github.com/dealii/dealii/pull/13327

#13326: Use the new CA interface instead of using AnonymousProcess. (proposed 
by bangerth) https://github.com/dealii/dealii/pull/13326

#13325: CMake: Modernize DEAL_II_PACKAGE_HANDLE macro and clean up Find*.cmake 
files (proposed by tamiko; merged) https://github.com/dealii/dealii/pull/13325

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

#13323: Micro simplication. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/13323

#13322: Deal with empty function objects in CA algorithms. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/13322

#13320: Replace is_detected (type) by is_supported_operation (variable). 
(proposed by bangerth; merged) https://github.com/dealii/dealii/pull/13320

#13319: CMake: call CMake's FindHDF5 instead of trying to find everything by 
hand (proposed by tamiko; merged) https://github.com/dealii/dealii/pull/13319

#13316: MatrixFreeTools::compute_diagonal(): do not initialize vector (proposed 
by peterrum; merged) https://github.com/dealii/dealii/pull/13316

#13315: `MatrixFreeTools::compute_diagonal`: introduce template parameter 
`VectorType` (proposed by mschreter; merged) 
https://github.com/dealii/dealii/pull/13315


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

#13348: Test fe_nedelec_sz_hessian_divergence_theorem.debug times out (opened) 
https://github.com/dealii/dealii/issues/13348

#13347: GMSH quad mesh with some cells with negative weight (opened) 
https://github.com/dealii/dealii/issues/13347

#13346: Negative det in MappingFE on some simplex mesh (opened) 
https://github.com/dealii/dealii/issues/13346

#13345: DataOut hdf5 does not support large files (opened) 
https://github.com/dealii/dealii/issues/13345

#13329: Link to wrong header file in Docu of MappingQ? (opened and closed) 
https://github.com/dealii/dealii/issues/13329

#13321: Replace std::pow with integer exponent (opened) 
https://github.com/dealii/dealii/issues/13321

#13295: Follow-ups to the introduction of `is_detected` (closed) 
https://github.com/dealii/dealii/issues/13295

#10561: Improve support of cell-data vectors in MatrixFree (closed) 
https://github.com/dealii/dealii/issues/10561

#8957: deal.II does not see the HDF5 package on Ubuntu 18.04 (closed) 
https://github.com/dealii/dealii/issues/8957


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 

[deal.II] deal.II Newsletter #199

2022-02-01 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

#13319: CMake: call CMake's FindHDF5 instead of trying to find everything by 
hand (proposed by tamiko) https://github.com/dealii/dealii/pull/13319

#13316: MatrixFreeTools::compute_diagonal(): do not initialize vector (proposed 
by peterrum) https://github.com/dealii/dealii/pull/13316

#13315: [WIP] `MatrixFreeTools::compute_diagonal`: introduce template parameter 
`VectorType` (proposed by mschreter) https://github.com/dealii/dealii/pull/13315

#13313: Enable FE_Nothing in DoFTools::extract_constant_modes (proposed by 
sebproell) https://github.com/dealii/dealii/pull/13313

#13312: Fix MGTwoLevelTransfer::restrict_and_add() (proposed by peterrum; 
merged) https://github.com/dealii/dealii/pull/13312

#13311: FEEval: rename get_is_interior_face() to is_interior_face() (proposed 
by peterrum; merged) https://github.com/dealii/dealii/pull/13311

#13310: Speed up evaluation of RefSpaceFEFieldFunction (proposed by 
kronbichler) https://github.com/dealii/dealii/pull/13310

#13309: Added hp-version for `VectorTools::compute_mean_value()`. (proposed by 
marcfehling; merged) https://github.com/dealii/dealii/pull/13309

#13307: Updates to manifolds classes (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/13307

#13306: Minor adjustments to the pipe junction geometry. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/13306

#13305: Add a missing assertion. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/13305

#13304: Improve the text of an assertion. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/13304

#13303: Rename Triangulation::manifold to Triangulation::manifolds. (proposed 
by bangerth; merged) https://github.com/dealii/dealii/pull/13303

#13302: Minor updates to the documentation of GridTools::transform(). (proposed 
by bangerth; merged) https://github.com/dealii/dealii/pull/13302

#13301: Avoid a couple of references to GeometryInfo. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/13301

#13300: Avoid 'using namespace' declarations. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/13300

#13299: Remove an unnecessary 'using namespace std' declaration. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/13299

#13298: Minor suggestions for step-55 (proposed by marcfehling; merged) 
https://github.com/dealii/dealii/pull/13298

#13296: Follow-up to is_detected. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/13296

#13294: fix a rendering issue with doxygen 1.9.3 (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/13294

#13293: Port 9.3.3 changelog changes to master. (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/13293

#13291: Use standardized detection idiom (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/13291

#13287: Introduce ReferenceCell::n_isotropic_children(). (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/13287

#13281: Introduce FEEval::*_face_data() (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/13281

#13272: Switch the consensus algorithms interface to using function objects. 
(proposed by bangerth; merged) https://github.com/dealii/dealii/pull/13272

#13269: Add a test for moving particles in a complex geometry and  (proposed by 
blaisb; merged) https://github.com/dealii/dealii/pull/13269

#13260: FEEval: allow to reinit with a batch with arbitrary cells (proposed by 
peterrum; merged) https://github.com/dealii/dealii/pull/13260

#13124: Manifold for `pipe_junction`. (proposed by marcfehling; merged) 
https://github.com/dealii/dealii/pull/13124

#12771: Add Hessian to FE_NedelecSZ (proposed by kinnewig; merged) 
https://github.com/dealii/dealii/pull/12771

#12757: Add a CutFEM tutorial as step-85 (proposed by simonsticko; merged) 
https://github.com/dealii/dealii/pull/12757


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

#13318: Compatibility with opencascade 7.6.0 (opened) 
https://github.com/dealii/dealii/issues/13318

#13317: size of sparsity pattern not consistent with number of dofs (opened and 
closed) https://github.com/dealii/dealii/issues/13317

#13314: PETScWrappers::MPI::Vector class gives no warning when trying to modify 
ghosted vectors (opened) https://github.com/dealii/dealii/issues/13314

#13308: Documentation of GeometryInfo and ReferenceCell unclear (opened) 
https://github.com/dealii/dealii/issues/13308

#13297: GMRES residual jump at restart when using multigrid matrix-free method 
(opened) https://github.com/dealii/dealii/issues/13297

#13295: Follow-ups to the introduction of `is_detected` (opened) 
https://github.com/dealii/dealii/issues/13295

#13228: 

[deal.II] deal.II Newsletter #198

2022-01-25 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

#13292: [9.3] update changelog entries for point release (proposed by tamiko; 
merged) https://github.com/dealii/dealii/pull/13292

#13291: Use standardized detection idiom (proposed by masterleinad) 
https://github.com/dealii/dealii/pull/13291

#13290: Reimplemen UpdateFlags as enum-like class (proposed by masterleinad) 
https://github.com/dealii/dealii/pull/13290

#13289: Fix a bogus warning about a null pointer in a lambda. (proposed by 
drwells; merged) https://github.com/dealii/dealii/pull/13289

#13288: Minor edits to type traits classes. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/13288

#13287: Introduce ReferenceCell::n_isotropic_children(). (proposed by bangerth) 
https://github.com/dealii/dealii/pull/13287

#13286: Make naming of function arguments more uniform. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/13286

#13285: PreconditionRelaxation: vmult/step w. relaxation (proposed by peterrum; 
merged) https://github.com/dealii/dealii/pull/13285

#13284: [9.3] Fix flags bug point_values (proposed by bergbauer; merged) 
https://github.com/dealii/dealii/pull/13284

#13283: SparseMatrix: rename om to omega (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/13283

#13282: Relax assert in MF::get_boundary_id() (proposed by peterrum) 
https://github.com/dealii/dealii/pull/13282

#13281: Introduce FEEval::*_face_data() (proposed by peterrum) 
https://github.com/dealii/dealii/pull/13281

#13280: Use MPI::Utilities::free_communicator() where possible. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/13280

#13279: Update docu of NonMatching::FEImmersedSurfaceValues (proposed by 
peterrum; merged) https://github.com/dealii/dealii/pull/13279

#13278: Fix bug in initial condition for transform_real_to_unit_cell (proposed 
by kronbichler; merged) https://github.com/dealii/dealii/pull/13278

#13277: Fix a sign error in step-22's introduction. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/13277

#13276: Hide forward declarations in `fe/fe.h` from doxygen. (proposed by 
marcfehling; merged) https://github.com/dealii/dealii/pull/13276

#13275: Small fix to the documentation in step-37 (proposed by CuiCu-618; 
merged) https://github.com/dealii/dealii/pull/13275

#13274: Add ifdefs for is_reinitialized in FEEval (proposed by peterrum; 
merged) https://github.com/dealii/dealii/pull/13274

#13273: Define MPI_COMM_NULL when not using MPI. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/13273

#13272: Switch the consensus algorithms interface to using function objects. 
(proposed by bangerth) https://github.com/dealii/dealii/pull/13272

#13271: Use relative tolerances in step-3. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/13271

#13270: Explain the use of iterative solvers in the introduction of step-3. 
(proposed by bangerth; merged) https://github.com/dealii/dealii/pull/13270

#13269: Add a test for moving particles in a complex geometry and  (proposed by 
blaisb) https://github.com/dealii/dealii/pull/13269

#13268: Fix LA::Vector::reinit() (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/13268

#13267: Remove the prepare_for_answer() callback in consensus algorithms. 
(proposed by bangerth; merged) https://github.com/dealii/dealii/pull/13267

#13266: Fix MF for LA::vector (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/13266

#13264: Review of `references.bib`. (proposed by marcfehling; merged) 
https://github.com/dealii/dealii/pull/13264

#13262: Do not store some things in the CA::Interface base class. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/13262

#13261: Minor doc update to the consensus algorithms. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/13261

#13259: FEEval: replace usages of n_vectorization_actual (proposed by peterrum; 
merged) https://github.com/dealii/dealii/pull/13259

#13257: PEX: Replace MPI_Irecv with MPI_Iprobe+MPI_Recv (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/13257

#13252: Move quadrature_points into FEEvalData (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/13252

#13219: Replace MPI_Irecv with MPI_Iprobe+MPI_Recv. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/13219

#13144: Fix omissions in GridGenerator::flatten_triangulation(). (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/13144

#13073: Convert a few more locally-owned loops with filters. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/13073


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

#13246: Randomly disappearing 

[deal.II] deal.II Newsletter #197

2022-01-18 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

#13262: Do not store some things in the CA::Interface base class. (proposed by 
bangerth) https://github.com/dealii/dealii/pull/13262

#13261: Minor doc update to the consensus algorithms. (proposed by bangerth) 
https://github.com/dealii/dealii/pull/13261

#13260: FEEval: allow to reinit with a batch with arbitrary cells (proposed by 
peterrum) https://github.com/dealii/dealii/pull/13260

#13259: FEEval: replace usages of n_vectorization_actual (proposed by peterrum) 
https://github.com/dealii/dealii/pull/13259

#13258: FEEval: do not use cell as indication if reinit() was called (proposed 
by peterrum; merged) https://github.com/dealii/dealii/pull/13258

#13257: PEX: Replace MPI_Irecv with MPI_Iprobe+MPI_Recv (proposed by bangerth) 
https://github.com/dealii/dealii/pull/13257

#13256: Hotfix: Avoid warning about implicit conversion to bool. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/13256

#13255: Use consistent grammar in the list of tutorial programs. (proposed by 
bangerth) https://github.com/dealii/dealii/pull/13255

#13254: Revert "Add clang-tidy check" (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/13254

#13253: Move jacobian_gradients into FEEvalData (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/13253

#13252: Move quadrature_points into FEEvalData (proposed by peterrum) 
https://github.com/dealii/dealii/pull/13252

#13251: FEEval: use get_cell_ids() at more places (proposed by peterrum; 
merged) https://github.com/dealii/dealii/pull/13251

#13250: Cleanup `references.bib`. (proposed by marcfehling; merged) 
https://github.com/dealii/dealii/pull/13250

#13249: Added bibtex entry for `refine_and_coarsen_optimize` reference. 
(proposed by marcfehling; merged) https://github.com/dealii/dealii/pull/13249

#13248: Typo correction (proposed by rschoof; merged) 
https://github.com/dealii/dealii/pull/13248

#13247: Rename variable (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/13247

#13245: Make reuse of mapping data in FEPointEvaluation safer (proposed by 
kronbichler) https://github.com/dealii/dealii/pull/13245

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

#13241: Make reference to SUNDIALS solvers in step-26. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/13241

#13240: FEEval: do not cast const away during read_dof_values() (proposed by 
peterrum; merged) https://github.com/dealii/dealii/pull/13240

#13239: Hermite finite elements - initial pull request (proposed by ivweber) 
https://github.com/dealii/dealii/pull/13239

#13238: Reference book directly in step-55. (proposed by marcfehling; merged) 
https://github.com/dealii/dealii/pull/13238

#13237: Added bibtex entry for SolverMinRes reference. (proposed by 
marcfehling; merged) https://github.com/dealii/dealii/pull/13237

#13236: fix two small typos (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/13236

#13235: Some updates to the PEX code (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/13235

#13234: [9.3] CMake: use portable "cmake -E remove" in quick_tests (proposed by 
marcfehling; merged) https://github.com/dealii/dealii/pull/13234

#13233: [9.3] Compatibility to oneAPI suite and oneTBB `apt` package. (proposed 
by marcfehling; merged) https://github.com/dealii/dealii/pull/13233

#13232: Validate correctness of input arguments. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/13232

#13231: Marginally accelerate compute_point_to_point_communication_pattern(). 
(proposed by bangerth; merged) https://github.com/dealii/dealii/pull/13231

#13230: Add a couple of assertions. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/13230

#13229: Add contains functions to check that flags contain a specific flag 
(proposed by masterleinad) https://github.com/dealii/dealii/pull/13229

#13227: CMake: adjust tbb path glob to "lib/intel64/gcc*" layout (proposed by 
tamiko; merged) https://github.com/dealii/dealii/pull/13227

#13226: Improve usability of PreconditionRelaxation (proposed by peterrum; 
merged) https://github.com/dealii/dealii/pull/13226

#13225: Fix Y-pipe example in doc for `pipe_junction`. (proposed by 
marcfehling; merged) https://github.com/dealii/dealii/pull/13225

#13224: [9.3] take over oneAPI fixes (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/13224

#13223: Automatically resize receive buffer in the NBX algorithm (proposed by 
bangerth) https://github.com/dealii/dealii/pull/13223

#13222: Add a changelog entry for #13165. (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/13222

#13221: Fix a redefined 

[deal.II] deal.II Newsletter #196

2022-01-10 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

#13211: Fix a check for zero entries in the lumped mass matrix. (proposed by 
drwells) https://github.com/dealii/dealii/pull/13211

#13210: Added changelog for p4est installation script. (proposed by 
marcfehling; merged) https://github.com/dealii/dealii/pull/13210

#13209: [9.3] Fix setup script for p4est>=2.3. (proposed by marcfehling) 
https://github.com/dealii/dealii/pull/13209

#13207: Cleanups in FETools::extrapolate() (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/13207

#13206: Fix a bug: Don't reuse buffers for MPI_Isend. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/13206

#13204: Remove occurances of /// in source/ (proposed by simonsticko; merged) 
https://github.com/dealii/dealii/pull/13204

#13203: Convert manual references into bibtex ones in step-43. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/13203

#13202: Faster and simpler search for lost particles (proposed by gassmoeller) 
https://github.com/dealii/dealii/pull/13202

#13201: Do not output the partitioner when pretty-printing Vector objects. 
(proposed by bangerth; merged) https://github.com/dealii/dealii/pull/13201

#13200: Updates to step-10 (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/13200

#13199: Minor edits to the documentation of SparsityPattern. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/13199

#13198: Be more thoughtful about parallel grain sizes in UMFPACK interfaces. 
(proposed by bangerth; merged) https://github.com/dealii/dealii/pull/13198

#13197: Document the meaning of jump_in/average_of_* in FEInterfaceValues. 
(proposed by bangerth; merged) https://github.com/dealii/dealii/pull/13197

#13196: Add to the documentation of SymmetricTensor::operator*. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/13196

#13195: Add movie to step-67 tutorial program (proposed by kronbichler; merged) 
https://github.com/dealii/dealii/pull/13195

#13192: Fix manifold copying on lines when converting hexes to tets. (proposed 
by drwells; merged) https://github.com/dealii/dealii/pull/13192

#13191: Simplify initialization of block systems in step-21. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/13191

#13190: Simplify initialization of block systems in step-20 (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/13190

#13189: Fix symbol confusion in step-52. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/13189

#13188: Document a part of step-43 that confused @tjhei. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/13188

#13187: Fix RemotePointEvalution::marked_vertices for vectors with only false 
(proposed by peterrum; merged) https://github.com/dealii/dealii/pull/13187

#13186: Use better variable names in step-43. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/13186

#13185: Provide some overloads and instantiations (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/13185

#13184: Fix serialization of empty SparsityPattern objects (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/13184

#13183: Simplify some code. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/13183

#13182: Add some more index range checks. (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/13182

#13181: Extend MeshWorker::ScratchData to support hp (proposed by jppelteret) 
https://github.com/dealii/dealii/pull/13181

#13180: [9.3] Boost 1.78 (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/13180

#13179: OneAPI compatibility: enable oneAPI configuration in CMake, changelog 
(proposed by tamiko) https://github.com/dealii/dealii/pull/13179

#13178: RemotePointEvalution: pass marked_vertices (proposed by peterrum; 
merged) https://github.com/dealii/dealii/pull/13178

#13177: FEPointEvaluation: fix types for multiple components (proposed by 
peterrum; merged) https://github.com/dealii/dealii/pull/13177

#13176: OneAPI compatibility: fix most of the API incompatibilities (proposed 
by tamiko; merged) https://github.com/dealii/dealii/pull/13176

#13175: Add a changelog entry. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/13175

#13174: Update step-44 documentation. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/13174

#13173: VectorTools::point_values(): fix types (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/13173

#13172: Use std::string::size() instead of std::string::length(). (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/13172

#13170: Add some more tests for iterator filters (proposed by 

[deal.II] deal.II Newsletter #195

2022-01-03 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

#13161: Extend ScratchData's public interface with getter methods to access 
private data (proposed by jppelteret; merged) 
https://github.com/dealii/dealii/pull/13161

#13160: step-74: add DOI (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/13160

#13159: Extend PreconditionRelaxation (proposed by peterrum) 
https://github.com/dealii/dealii/pull/13159

#13158: Add get_embedding_dofs() to FE_Nedelec (2-D) (proposed by harmonj) 
https://github.com/dealii/dealii/pull/13158

#13157: Avoid a temp array in the UMFPACK interfaces. (proposed by bangerth) 
https://github.com/dealii/dealii/pull/13157

#13156: Also simplify parallel::accumulate_from_subranges() with lambdas. 
(proposed by bangerth) https://github.com/dealii/dealii/pull/13156

#13155: Parallelize some functions setting up UMFPACK. (proposed by bangerth) 
https://github.com/dealii/dealii/pull/13155

#13154: Iterator filter predicates for boundary and manifold IDs (proposed by 
jppelteret; merged) https://github.com/dealii/dealii/pull/13154

#13153: Simplify more code in parallel.h via lambda functions. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/13153

#13152: Refactor PreconditionRelaxation (proposed by peterrum) 
https://github.com/dealii/dealii/pull/13152

#13151: Simplify code by using lambda functions. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/13151

#13150: Avoid implicit bool conversions (proposed by masterleinad) 
https://github.com/dealii/dealii/pull/13150

#13149: [WIP] Add Kokkos backend in LinearAlgebra::distributed::Vector 
(proposed by Rombur) https://github.com/dealii/dealii/pull/13149

#13147: Add a bit of documentation to 
MPI::compute_point_to_point_communication_pattern() (proposed by bangerth) 
https://github.com/dealii/dealii/pull/13147

#13146: Fix compilation with 64-bit integers (proposed by kronbichler; merged) 
https://github.com/dealii/dealii/pull/13146

#13145: typo in docu of fourth order unit tensor (SymmetricTensor<4, dim, 
Number> identity_tensor()) (proposed by jfriedlein; merged) 
https://github.com/dealii/dealii/pull/13145

#13144: Fix omissions in GridGenerator::flatten_triangulation(). (proposed by 
bangerth) https://github.com/dealii/dealii/pull/13144

#13143: Bug in gmsh api writer. (proposed by luca-heltai) 
https://github.com/dealii/dealii/pull/13143

#13142: Add a bunch of dummy functions for TriaAccessor<0,1,spacedim>. 
(proposed by bangerth; merged) https://github.com/dealii/dealii/pull/13142

#13141: Add assertions and a test (proposed by bangerth) 
https://github.com/dealii/dealii/pull/13141

#13140: Make sure HOME, WORKDIR, and MPI env vars are set correctly. (proposed 
by luca-heltai; merged) https://github.com/dealii/dealii/pull/13140

#13139: Small cleanup in SD::BatchOptimizer (proposed by jppelteret; merged) 
https://github.com/dealii/dealii/pull/13139

#13138: github-actions: cache Intel workflow (proposed by marcfehling; merged) 
https://github.com/dealii/dealii/pull/13138

#13137: fix docker.yml - try 3 (proposed by marcfehling; merged) 
https://github.com/dealii/dealii/pull/13137

#13136: Add a hash to SymEngine expression wrapper (proposed by jppelteret) 
https://github.com/dealii/dealii/pull/13136

#13135: Add SD::BatchOptimizer::copy_from() function (proposed by jppelteret; 
merged) https://github.com/dealii/dealii/pull/13135

#13134: Fix a bug in SD::BatchOptimizer::extract() (proposed by jppelteret; 
merged) https://github.com/dealii/dealii/pull/13134

#13133: SD::BatchOptimizer: Corrected location for a set of assertions. 
(proposed by jppelteret; merged) https://github.com/dealii/dealii/pull/13133

#13132: Add an assertion to GridGenerator::flatten_triangulation(). (proposed 
by bangerth; merged) https://github.com/dealii/dealii/pull/13132

#13130: Update documentation of GridGenerator::flatten_triangulation(). 
(proposed by bangerth; merged) https://github.com/dealii/dealii/pull/13130

#13129: CMake: use portable "rm" in quick_tests (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/13129

#13128: More minor changes to GridGenerator::flatten_triangulation(). (proposed 
by bangerth; merged) https://github.com/dealii/dealii/pull/13128

#13125: fix docker.yml - try 2. (proposed by luca-heltai; merged) 
https://github.com/dealii/dealii/pull/13125

#13124: Manifold for `pipe_junction`. (proposed by marcfehling) 
https://github.com/dealii/dealii/pull/13124

#13123: [9.3] sundials fix (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/13123

#13121: Calculate cross product once. (proposed by marcfehling; merged) 
https://github.com/dealii/dealii/pull/13121

#13120: Add docker image with root user. (proposed by luca-heltai; merged) 

[deal.II] deal.II Newsletter #194

2021-12-20 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

#13102: Correct typo (math rendering) (proposed by mwichro) 
https://github.com/dealii/dealii/pull/13102

#13101: Bug fix of MF face eval for hanging nodes and non-standard orientation 
(proposed by kronbichler) https://github.com/dealii/dealii/pull/13101

#13099: [WIP] Global coarsening: compress weights (proposed by peterrum) 
https://github.com/dealii/dealii/pull/13099

#13097: Util::MPI::compute_n_point_to_point_communications() add fallback 
(proposed by peterrum) https://github.com/dealii/dealii/pull/13097

#13096: Boundary values: Use alias fe instead of cell->get_fe() (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/13096

#13095: Fixed bug in SparseDirectUMFPACK #12916 (proposed by kuljitvirk) 
https://github.com/dealii/dealii/pull/13095

#13094: Fix a comment's grammar. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/13094

#13093: Remove a redundant argument to xargs. (proposed by drwells) 
https://github.com/dealii/dealii/pull/13093

#13091: Alternative way to avoid warnings. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/13091

#13090: Fix a warning about array accesses. (proposed by bangerth) 
https://github.com/dealii/dealii/pull/13090

#13088: Avoid the need for empty lambda functions in 
ConsensusAlgorithms::AnonymousProcess. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/13088

#13087: Minor fix to an error message. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/13087

#13086: Rename 'filter' to 'filter.pl'. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/13086

#13083: Document exception behavior for threads. (proposed by bangerth) 
https://github.com/dealii/dealii/pull/13083

#13082: Allow multiple messages to the same target in the NPX algorithm. 
(proposed by bangerth) https://github.com/dealii/dealii/pull/13082

#13081: Update step-66 (proposed by gfcas; merged) 
https://github.com/dealii/dealii/pull/13081

#13080: Minor doc changes to the consensus algorithms (proposed by bangerth) 
https://github.com/dealii/dealii/pull/13080

#13079: Evaluation kernels: Avoid checking the orientations in inner loop 
(proposed by kronbichler) https://github.com/dealii/dealii/pull/13079

#13078: Eliminate FEEvaluationData::get_all_face_numbers () and 
get_all_face_orientations () (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/13078

#13077: Evaluation kernels: Make sure to pick vectorized gather function 
(proposed by kronbichler; merged) https://github.com/dealii/dealii/pull/13077

#13076: MatrixFree::gather_evalute(): allow mixed numbers (proposed by 
peterrum; merged) https://github.com/dealii/dealii/pull/13076

#13075: Remove an unnecessary semicolon. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/13075

#13073: Convert a few more locally-owned loops with filters. (proposed by 
bangerth) https://github.com/dealii/dealii/pull/13073

#13072: Fix the spelling of a function name. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/13072

#13071: Use one instead of two regexes. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/13071

#13070: Ignore some more TBB warnings. (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/13070

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

#13068: Add some explicit casts to IndexSet. (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/13068

#13067: [WIP] Geometric global coarsening: enable FE_Nothing (proposed by 
peterrum) https://github.com/dealii/dealii/pull/13067

#13066: Avoid quadratic complexity in IndexSet::subtract_set (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/13066

#13065: Global coarsening: specialize code for FE_Q (proposed by peterrum; 
merged) https://github.com/dealii/dealii/pull/13065

#13064: Global coarsening: simplify the determination of weights (proposed by 
peterrum; merged) https://github.com/dealii/dealii/pull/13064

#13063: [WIP] Implement FEFaceEvaluation::evaluate() for ECL/unstructured 
meshes (proposed by peterrum) https://github.com/dealii/dealii/pull/13063

#13062: Fix some various typos and dead links. (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/13062

#13061: Fix pyramid output in DataOutBase::write_gnuplot(). (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/13061

#13060: Also support wedges and pyramids in GridOut::write_gnuplot() (proposed 
by bangerth; merged) https://github.com/dealii/dealii/pull/13060

#13059: Add tests for MatrixFree + shared-memory MPI (proposed by peterrum; 
merged) 

[deal.II] deal.II Newsletter #193

2021-12-06 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

#13035: Enable GridOut::write_gmsh() for simplex meshes (proposed by bangerth) 
https://github.com/dealii/dealii/pull/13035

#13033: Install tests/tests.h (proposed by peterrum) 
https://github.com/dealii/dealii/pull/13033

#13032: WorkStream cleanups (proposed by bangerth) 
https://github.com/dealii/dealii/pull/13032

#13031: Minimal change to make WorkStream work with newer TBB versions. 
(proposed by bangerth; merged) https://github.com/dealii/dealii/pull/13031

#13029: Remove references to DEAL_II_EXPLICIT_CONSTRUCTOR_BUG. (proposed by 
drwells; merged) https://github.com/dealii/dealii/pull/13029

#13028: Generator for `tee` geometries. (proposed by marcfehling) 
https://github.com/dealii/dealii/pull/13028

#13027: Allow accessing face numbers in data postprocessors (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/13027

#13026: Adjust assert in Physics::VectorRelations. (proposed by marcfehling; 
merged) https://github.com/dealii/dealii/pull/13026

#13025: Fix test `mpi/hp_step-4`. (proposed by marcfehling; merged) 
https://github.com/dealii/dealii/pull/13025

#13024: Explicitly wait for tasks to be done. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/13024

#13023: Add an tutorial for distributed memory parallel simulation of heat 
equation (proposed by MarkMa1990) https://github.com/dealii/dealii/pull/13023

#13022: CI: replace windows-2016 by windows-2022 (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/13022

#13021: Boost includes: use BOOST_ALLOW_DEPRECATED_HEADERS to suppress warnings 
(proposed by tamiko; merged) https://github.com/dealii/dealii/pull/13021

#13019: Skip a bunch of work for tests that we don't actually want. (proposed 
by bangerth) https://github.com/dealii/dealii/pull/13019

#13018: Spawn tasks via the TBB again. (proposed by bangerth) 
https://github.com/dealii/dealii/pull/13018

#13017: Make evaluation_kernels only include FEEvaluationData file (proposed by 
kronbichler) https://github.com/dealii/dealii/pull/13017

#13016: Do not use uninitialized variable in tests (proposed by kronbichler; 
merged) https://github.com/dealii/dealii/pull/13016

#13015: Guard a forward declaration. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/13015

#13014: Avoid unnecessary memory allocation. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/13014

#13013: Move implementation for ShapeInfo to templates.h file (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/13013

#13012: Start from zero vector for MG coarse solver (proposed by kronbichler) 
https://github.com/dealii/dealii/pull/13012

#13011: Use narrowest possible SIMD vector for MappingQ::InternalData (proposed 
by kronbichler; merged) https://github.com/dealii/dealii/pull/13011

#13010: Use a simpler way to clear a vector. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/13010

#13009: Use a simpler way to initialize default arguments. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/13009

#13008: Functions for calculating angles between vectors. (proposed by 
marcfehling; merged) https://github.com/dealii/dealii/pull/13008

#13007: [WIP] Bundling Kokkos (proposed by Rombur) 
https://github.com/dealii/dealii/pull/13007

#13006: Use internal rotation matrix for airfoil. (proposed by marcfehling; 
merged) https://github.com/dealii/dealii/pull/13006

#13005: Fix a memory leak in AlignedVector. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/13005

#12999: Add FEEvaluationImplHangingNodes::RunTypes::scalar (proposed by 
peterrum; merged) https://github.com/dealii/dealii/pull/12999

#12756: Add class NonMatching::FEValues (proposed by simonsticko; merged) 
https://github.com/dealii/dealii/pull/12756


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

#13034: Wrong .prm files in step-60 (opened) 
https://github.com/dealii/dealii/issues/13034

#13030: SparsityPattern serialization causing segfault (opened) 
https://github.com/dealii/dealii/issues/13030

#13020: BOOST uses deprecated BOOST headers :-( (opened) 
https://github.com/dealii/dealii/issues/13020

#12998: Memory leak `Table`/`AlignedVector` (closed) 
https://github.com/dealii/dealii/issues/12998


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 

[deal.II] deal.II Newsletter #192

2021-11-29 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

#13004: Avoid dereferencing a past-the-end iterator (proposed by kronbichler) 
https://github.com/dealii/dealii/pull/13004

#13003: Use pre-compiled code for CellwiseInverseMassMatrix (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/13003

#13002: Fix and augment documentation. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/13002

#13001: Introduce internal::VectorizedArrayTrait and use it (proposed by 
peterrum; merged) https://github.com/dealii/dealii/pull/13001

#13000: Help compiler exploit hanging-node symmetries by reduced reg loads 
(proposed by kronbichler; merged) https://github.com/dealii/dealii/pull/13000

#12999: Add FEEvaluationImplHangingNodes::RunTypes::scalar (proposed by 
peterrum) https://github.com/dealii/dealii/pull/12999

#12997: Move FEEvaluationImplHangingNodes::run_internal() into a specialized 
class (proposed by peterrum; merged) https://github.com/dealii/dealii/pull/12997

#12996: Stylist clean-up in FEEvaluationImplHangingNodes (proposed by peterrum; 
merged) https://github.com/dealii/dealii/pull/12996

#12995: Use std::vector instead of Table (proposed by elauksap; merged) 
https://github.com/dealii/dealii/pull/12995

#12994: Vectorize evaluation of hanging node interpolation (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/12994

#12992: Fix bug MatrixFree::reinit (proposed by Rombur; merged) 
https://github.com/dealii/dealii/pull/12992

#12991: delete sequential code in big MPI datatype  (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/12991

#12990: Do not split evaluation_template_factory_hanging_nodes instantiations 
(proposed by kronbichler) https://github.com/dealii/dealii/pull/12990

#12989: Fix compile warning by adding copy constructor to hp iterator (proposed 
by kronbichler; merged) https://github.com/dealii/dealii/pull/12989

#12988: Use extractors for local_rhs in step-22 (proposed by fdrmrc; merged) 
https://github.com/dealii/dealii/pull/12988

#12987: Make sure MPI BigData objects are always destroyed. (proposed by 
bangerth) https://github.com/dealii/dealii/pull/12987

#12985: Improve default behaviour of CUDAWrappers::MatrixFree::reinit() 
(proposed by peterrum; merged) https://github.com/dealii/dealii/pull/12985

#12984: Remove set_vertex_dof_index(). (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/12984

#12983: Allow reusing mapping data in FEPointEvaluation (proposed by 
gassmoeller) https://github.com/dealii/dealii/pull/12983

#12982: Add iterator traits to hp::CollectionIterator (proposed by peterrum; 
merged) https://github.com/dealii/dealii/pull/12982

#12981: VectorizedArray: Simplify compare_and_apply_mask by blend instruction 
(proposed by kronbichler; merged) https://github.com/dealii/dealii/pull/12981

#12980: Fix CellAccessor::neighbor_child_on_subface() (proposed by peterrum; 
merged) https://github.com/dealii/dealii/pull/12980

#12979: Fix GridGenerator::merge_triangulations() for simplex meshes (proposed 
by peterrum; merged) https://github.com/dealii/dealii/pull/12979

#12978: add Assert to get_mg_dof_indices (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/12978

#12977: Refactor HangingNodes::setup_constraints() (proposed by peterrum; 
merged) https://github.com/dealii/dealii/pull/12977

#12976: Add assert to FEImmersedSurfaceValues (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/12976

#12975: Added extractors in local_rhs in step-22 (proposed by fdrmrc) 
https://github.com/dealii/dealii/pull/12975

#12973: fix checkpointing with >2GB per process (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/12973

#12972: Update the documentation on iterator filters. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/12972

#12971: Use iterator filters in tests/. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/12971

#12969: Fix bug in build system when using Kokkos (proposed by Rombur; merged) 
https://github.com/dealii/dealii/pull/12969

#12967: More work for COMSOL meshes (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/12967

#12965: Use iterator filters in our code base. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/12965


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

#12998: Memory leak `Table`/`AlignedVector` (opened) 
https://github.com/dealii/dealii/issues/12998

#12993: Memory leak with simplex meshes (opened and closed) 
https://github.com/dealii/dealii/issues/12993

#12986: Big MPI data type test fails (opened) 
https://github.com/dealii/dealii/issues/12986

#12974: Bug: writing large vtu files fails (opened) 

[deal.II] deal.II Newsletter #191

2021-11-19 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

#12970: Replace cancel-builds-on-update by concurrency feature in the GitHub CI 
(proposed by masterleinad) https://github.com/dealii/dealii/pull/12970

#12969: Fix bug in build system when using Kokkos (proposed by Rombur) 
https://github.com/dealii/dealii/pull/12969

#12968: Trilinos parallel is_non_negative() function (proposed by juleoc02) 
https://github.com/dealii/dealii/pull/12968

#12967: More work for COMSOL meshes (proposed by bangerth) 
https://github.com/dealii/dealii/pull/12967

#12966: FEEvaluation: Select correct code path for cell neighbors (proposed by 
bergbauer; merged) https://github.com/dealii/dealii/pull/12966

#12965: Use iterator filters in our code base. (proposed by bangerth) 
https://github.com/dealii/dealii/pull/12965

#12964: Utilities::MPI::create_mpi_data_type_n_bytes (proposed by tjhei) 
https://github.com/dealii/dealii/pull/12964

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

#12962: CellIteratorContainer: inline function (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/12962

#12961: Make the 'direction' argument of some GridTools functions 'unsigned'. 
(proposed by bangerth; merged) https://github.com/dealii/dealii/pull/12961

#12960: Fix shadowing warning (proposed by Rombur) 
https://github.com/dealii/dealii/pull/12960

#12959: ConstraintKinds: implement memory_consumption() (proposed by peterrum; 
merged) https://github.com/dealii/dealii/pull/12959

#12958: Support for TBB OneAPI (proposed by tamiko) 
https://github.com/dealii/dealii/pull/12958

#12957: Work around a (wrong) warning about an unused variable. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/12957

#12956: Remove some duplication in MappingCartesian (proposed by simonsticko; 
merged) https://github.com/dealii/dealii/pull/12956

#12955: Introduce mask in read_dof_values (proposed by bergbauer; merged) 
https://github.com/dealii/dealii/pull/12955

#12954: Optimize Utilities::MPI::broadcast for built-in types (proposed by 
fAndreuzzi) https://github.com/dealii/dealii/pull/12954

#12953: Make dimension counters unsigned. (proposed by bangerth) 
https://github.com/dealii/dealii/pull/12953

#12952: Provide C++20-style operator| to filter iterator ranges. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/12952

#12951: Minor updates to the documentation of CellData. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/12951

#12950: Add the ability to output tet meshes in gnuplot format. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/12950

#12949: Add the ability to read COMSOL .mphtxt files. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/12949

#12948: Step-64: be explicit regarding templater parameter (proposed by 
peterrum; merged) https://github.com/dealii/dealii/pull/12948

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

#12946: std::unique_ptr -> CellIteratorContainer 
(proposed by peterrum; merged) https://github.com/dealii/dealii/pull/12946

#12945: Rename ConstraintKinds::type to subcell (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/12945

#12944: Check ConstraintKinds (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/12944

#12943: Improve an error message. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/12943

#12942: Convert loops in some tests to reference-cell-independent form. 
(proposed by bangerth; merged) https://github.com/dealii/dealii/pull/12942

#12941: FEValuesBase: move content around (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/12941

#12940: Improve build system when using Kokkos (proposed by Rombur) 
https://github.com/dealii/dealii/pull/12940

#12939: Streamline documentation. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/12939

#12938: Minor cleanups in thread_management.h. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/12938

#12937: Improve assert message in DictionaryPayLoad (proposed by peterrum; 
merged) https://github.com/dealii/dealii/pull/12937

#12931: Optimize particle generation (proposed by gassmoeller; merged) 
https://github.com/dealii/dealii/pull/12931

#12024: Add class FEImmersedSurfaceValues (proposed by simonsticko; merged) 
https://github.com/dealii/dealii/pull/12024


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

#12933: Error with distribute_sparsity_pattern (closed) 
https://github.com/dealii/dealii/issues/12933

#12435: lapack include variable (closed) 
https://github.com/dealii/dealii/issues/12435


A list of all major changes since the 

[deal.II] deal.II Newsletter #190

2021-11-12 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

#12937: Improve assert message in DictionaryPayLoad (proposed by peterrum) 
https://github.com/dealii/dealii/pull/12937

#12936: MatrixFreeFunctions::ConstraintKinds: rename and reorder (proposed by 
peterrum; merged) https://github.com/dealii/dealii/pull/12936

#12935: Improve an error message. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/12935

#12934: Mark FEValuesExtrator objects as 'const'. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/12934

#12932: FEValues: simplify CellIteratorBase (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/12932

#12931: Optimize particle generation (proposed by gassmoeller) 
https://github.com/dealii/dealii/pull/12931

#12930: FEValues: explicitly instantiate functions (proposed by peterrum) 
https://github.com/dealii/dealii/pull/12930

#12929: Rename some tests (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/12929

#12928: minor MGRepartining edits (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/12928

#12927: Minor fixes to `predict_error` doc. (proposed by marcfehling; merged) 
https://github.com/dealii/dealii/pull/12927

#12926: Update predict_error doc entry (proposed by gfcas; merged) 
https://github.com/dealii/dealii/pull/12926

#12924: MGTwoLevelTransfer (p): add fallback FE case (proposed by peterrum) 
https://github.com/dealii/dealii/pull/12924

#12923: Enable FETools::get_projection_matrix() for multiple components 
(proposed by peterrum; merged) https://github.com/dealii/dealii/pull/12923

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

#12922: CylindricalManifold: make member variable const. (proposed by 
marcfehling; merged) https://github.com/dealii/dealii/pull/12922

#12921: N_Vector now returns a pointer to MPI_Comm (proposed by sebproell; 
merged) https://github.com/dealii/dealii/pull/12921

#12920: Add signed distance function for 1D and 2D ellipsoids (proposed by 
nmuch; merged) https://github.com/dealii/dealii/pull/12920

#12918: [9.3] add changelog entry for point release (proposed by tamiko; 
merged) https://github.com/dealii/dealii/pull/12918

#12917: add changelog entry for point release (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/12917

#12915: [9.3.2] Revert "Remove copy from SUNDIALS::KINSOL" (proposed by 
masterleinad; merged) https://github.com/dealii/dealii/pull/12915

#12913: ParticleHandler: Store vector of particles per cell in std::list 
(proposed by kronbichler; merged) https://github.com/dealii/dealii/pull/12913


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

#12933: Error with distribute_sparsity_pattern (opened) 
https://github.com/dealii/dealii/issues/12933

#12914: Compilation error when using Sundials and MPICH (closed) 
https://github.com/dealii/dealii/issues/12914


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/618e9da9.1c69fb81.72950.287fSMTPIN_ADDED_MISSING%40gmr-mx.google.com.


[deal.II] deal.II Newsletter #189

2021-11-05 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

#12921: N_Vector now returns a pointer to MPI_Comm (proposed by sebproell) 
https://github.com/dealii/dealii/pull/12921

#12920: Add signed distance function for 1D and 2D ellipsoids (proposed by 
nmuch) https://github.com/dealii/dealii/pull/12920

#12919: Fix some errors revealed by STL debug compile (proposed by kronbichler) 
https://github.com/dealii/dealii/pull/12919

#12918: [9.3] add changelog entry for point release (proposed by tamiko) 
https://github.com/dealii/dealii/pull/12918

#12917: add changelog entry for point release (proposed by tamiko) 
https://github.com/dealii/dealii/pull/12917

#12915: [9.3.2] Revert "Remove copy from SUNDIALS::KINSOL" (proposed by 
masterleinad) https://github.com/dealii/dealii/pull/12915

#12913: ParticleHandler: Store vector of particles per cell in std::list 
(proposed by kronbichler) https://github.com/dealii/dealii/pull/12913

#12912: Fix the dates in four changelog entries. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/12912

#12911: Enable gnuplot output for simplices, pyramids, and wedges (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/12911

#12910: Fix a typo in step38 doc (proposed by fdrmrc; merged) 
https://github.com/dealii/dealii/pull/12910

#12909: FEEvaluation: Evaluate and integrate functions which use a user 
shape_info object (proposed by bergbauer; merged) 
https://github.com/dealii/dealii/pull/12909

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

#12907: Avoid code duplication. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/12907

#12905: Cleanups in data_out_base.cc (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/12905

#12904: Simplify code by using cell->is_locally_owned() and friends (proposed 
by kronbichler; merged) https://github.com/dealii/dealii/pull/12904

#12903: Inline active_cell_index functions (proposed by kronbichler; merged) 
https://github.com/dealii/dealii/pull/12903

#12902: Apply some range-based for loops (proposed by kronbichler; merged) 
https://github.com/dealii/dealii/pull/12902

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

#12896: Split up matrix_tools.h -> matrix_creator.h (proposed by peterrum; 
merged) https://github.com/dealii/dealii/pull/12896

#12895: Make DataOutFaces work with simplices (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/12895


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

#12916: SparseDirectUMFPACK does not work correctly with BlockSparseMatrix 
(opened) https://github.com/dealii/dealii/issues/12916

#12914: Compilation error when using Sundials and MPICH (opened) 
https://github.com/dealii/dealii/issues/12914

#12906: Support wedges and pyramids in DataOutFaces (opened) 
https://github.com/dealii/dealii/issues/12906

#12900: test failures from dataout changes (opened and closed) 
https://github.com/dealii/dealii/issues/12900

#11106: clang-format version (closed) 
https://github.com/dealii/dealii/issues/11106


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/61855519.1c69fb81.4b345.ad6aSMTPIN_ADDED_MISSING%40gmr-mx.google.com.


[deal.II] deal.II Newsletter #188

2021-10-29 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

#12899: Improve an error message. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/12899

#12898: Allow gnuplot output for triangles. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/12898

#12897: Fix some typos (proposed by gfcas; merged) 
https://github.com/dealii/dealii/pull/12897

#12896: Split up matrix_tools.h -> matrix_creator.h (proposed by peterrum) 
https://github.com/dealii/dealii/pull/12896

#12895: Make DataOutFaces work with simplices (proposed by bangerth) 
https://github.com/dealii/dealii/pull/12895

#12893: hp::Collection: allow range-based loop (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/12893

#12892: MGTwoLevelTransfer: make AffineConstraints optional (proposed by 
peterrum; merged) https://github.com/dealii/dealii/pull/12892

#12891: MGTwoLevelTransfer: enable FE_Nothing (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/12891

#12890: ARKode: set stop time for incremental solve (proposed by sebproell) 
https://github.com/dealii/dealii/pull/12890

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

#12888: Simplify the code for outputting data in gnuplot format. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/12888

#12887: Relax an assert in DoFTools::map_dofs_to_support_points (proposed by 
Rombur; merged) https://github.com/dealii/dealii/pull/12887

#12886: Fix typos in hp::FECollection doc (proposed by gfcas; merged) 
https://github.com/dealii/dealii/pull/12886

#12885: It's never just one thing... (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/12885

#12884: Corrections in Step-45 (proposed by marcfehling; merged) 
https://github.com/dealii/dealii/pull/12884

#12883: Added DOI for the tutorial program step-82 (proposed by dianeguignard; 
merged) https://github.com/dealii/dealii/pull/12883

#12882: [9.3] Cherry pick #12634 (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/12882

#12881: [9.3] Cherry pick #12830 (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/12881

#12880: Rename some variables in MGTransferGlobalCoarsening (proposed by 
peterrum; merged) https://github.com/dealii/dealii/pull/12880

#12879: Fix compilation of MGTransferGlobalCoarsening::interpolate_to_mg() 
(proposed by peterrum; merged) https://github.com/dealii/dealii/pull/12879

#12878: Introduce TriaAccessor::combined_face_orientation() (proposed by 
peterrum; merged) https://github.com/dealii/dealii/pull/12878

#12877: Do not preset Patch::reference_cell. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/12877

#12876: Fix Patch member functions. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/12876

#12875: Make Patch<0,spacedim>::reference_cell const. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/12875

#12874: Make Patch<0,spacedim>::n_subdivisions a 'const' variable. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/12874

#12872: Fix a typo. (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/12872

#12871: avoid unused variable warning (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/12871

#12869: Fix docu of PreconditionChebyshev (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/12869

#12868: Make code a bit more readable. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/12868

#12867: Make code a bit more readable. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/12867

#12866: Update class Quadrature in a couple of ways (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/12866

#12865: Avoid generation of expensive FE objects. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/12865

#12864: PETScWrappers::MPI::Vector: add new reinit() (proposed by peterrum; 
merged) https://github.com/dealii/dealii/pull/12864

#12863: SparseMatrix::reinit(): accept other sparse matrix (proposed by 
peterrum; merged) https://github.com/dealii/dealii/pull/12863

#12862: MatrixCreator: make SparseMatrixType a template parameter (proposed by 
peterrum; merged) https://github.com/dealii/dealii/pull/12862

#12861: Add a changelog entry for pr12787 (proposed by vachan-potluri; merged) 
https://github.com/dealii/dealii/pull/12861

#12860: Do not a priori allocate memory for objects that will later be 
re-sized. (proposed by bangerth) https://github.com/dealii/dealii/pull/12860

#12859: Towards making DataOutFaces work with simplices. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/12859

#12858: Add 

[deal.II] deal.II Newsletter #187

2021-10-21 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

#12856: Fix typo (proposed by gfcas) https://github.com/dealii/dealii/pull/12856

#12855: fix step-49 geo file (proposed by tjhei) 
https://github.com/dealii/dealii/pull/12855

#12853: Implement convert_generalized_support_point_values_to_dof_values for 
wedges/pyramids (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/12853

#12852: No more magic number Pi. (proposed by marcfehling; merged) 
https://github.com/dealii/dealii/pull/12852

#12851: DataOut: add wedge/pyramid test (proposed by peterrum) 
https://github.com/dealii/dealii/pull/12851

#12850: PreconditionChebyshev: Update documentation (proposed by kronbichler; 
merged) https://github.com/dealii/dealii/pull/12850

#12849: Reduce duplication of information. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/12849

#12848: Systematize construction of vertices for wedges. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/12848

#12847: [WIP] DataOut for pyramids: reorder at the end (proposed by peterrum) 
https://github.com/dealii/dealii/pull/12847

#12846: Rename Functions::LevelSet -> Functions::SignedDistance (proposed by 
peterrum; merged) https://github.com/dealii/dealii/pull/12846

#12845: Fix order of vertices of wedges in ReferenceCell::vertex (proposed by 
peterrum; merged) https://github.com/dealii/dealii/pull/12845

#12844: Replace uses of GeometryInfo. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/12844

#12843: Systematize vertex construction. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/12843

#12841: Simplify some code by using std::any_of(). (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/12841

#12840: Fix MatrixCreator::create_mass/laplace_matrix for hp (proposed by 
peterrum; merged) https://github.com/dealii/dealii/pull/12840

#12839: Use some more std::arrays. (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/12839

#12838: FE_Q_iso_Q1: varying subdivisions (proposed by peterrum) 
https://github.com/dealii/dealii/pull/12838

#12837: QIterated: varying subdivisions (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/12837

#12836: Fix determination of identity in MGTwoLevelTransfer (proposed by 
peterrum; merged) https://github.com/dealii/dealii/pull/12836

#12835: Add include to mg_transfer_global_coarsening.h (proposed by peterrum; 
merged) https://github.com/dealii/dealii/pull/12835

#12834: Add one, fix another assertion. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/12834

#12833: Simplify a piece of code. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/12833

#12832: variable checkpointing fixes for >4GB files (proposed by tjhei) 
https://github.com/dealii/dealii/pull/12832

#12830: fix checkpointing for >4GB files (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/12830

#12829: Add assert to check the definition of CellData (proposed by peterrum; 
merged) https://github.com/dealii/dealii/pull/12829

#12822: Minor text updates to the step-49 gmsh discussion. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/12822

#12819: Enable PreconditionChebyshev to update a sub-range of vector entries 
(proposed by kronbichler; merged) https://github.com/dealii/dealii/pull/12819

#12816: Generalize `GridTools::rotate` for arbitrary rotation axes. (proposed 
by marcfehling; merged) https://github.com/dealii/dealii/pull/12816

#12811: Correction of comments in step-72 (proposed by gfcas; merged) 
https://github.com/dealii/dealii/pull/12811

#12787: Ignore any sections before 2411 in `GridIn::read_unv()` (proposed by 
vachan-potluri; merged) https://github.com/dealii/dealii/pull/12787

#12341: Feature p4est find partition - Find MPI ranks of point owners in 
distributed meshes (proposed by konsim83; merged) 
https://github.com/dealii/dealii/pull/12341


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

#12854: constant_modes for PreconditionAMG (opened) 
https://github.com/dealii/dealii/issues/12854

#12842: Ordering of vertices for wedges and pyramids (opened) 
https://github.com/dealii/dealii/issues/12842

#12831: compiling issue (opened and closed) 
https://github.com/dealii/dealii/issues/12831


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 

[deal.II] deal.II Newsletter #186

2021-10-14 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

#12828: Implement functions within instead of outside a namespace. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/12828

#12827: Implement ReferenceCell::vertex(). (proposed by bangerth) 
https://github.com/dealii/dealii/pull/12827

#12825: Do not communicate vertices automatically to p4est in debug mode. 
(proposed by marcfehling) https://github.com/dealii/dealii/pull/12825

#12824: Make DataOutFaces work with simplex meshes. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/12824

#12823: checkpointing test with LA::distributed::Vector (proposed by tjhei) 
https://github.com/dealii/dealii/pull/12823

#12822: Minor text updates to the step-49 gmsh discussion. (proposed by 
bangerth) https://github.com/dealii/dealii/pull/12822

#12821: Introde Utilities::MemorySpace namespace and MemoryBlock class 
(proposed by Rombur) https://github.com/dealii/dealii/pull/12821

#12820: Fix typos (proposed by gfcas; merged) 
https://github.com/dealii/dealii/pull/12820

#12819: Enable PreconditionChebyshev to update a sub-range of vector entries 
(proposed by kronbichler) https://github.com/dealii/dealii/pull/12819

#12818: step-70: Remove quadrature_formula class attributes (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/12818

#12816: Generalize `GridTools::rotate` for arbitrary rotation axes. (proposed 
by marcfehling) https://github.com/dealii/dealii/pull/12816

#12814: Changelog entry for Step-45 (proposed by rnpratoori) 
https://github.com/dealii/dealii/pull/12814

#12813: Corrections in Step-45 (proposed by rnpratoori) 
https://github.com/dealii/dealii/pull/12813

#12812: step-72: Remove double quadrature_formula definition (proposed by 
gfcas; merged) https://github.com/dealii/dealii/pull/12812

#12811: Correction of comments in step-72 (proposed by gfcas) 
https://github.com/dealii/dealii/pull/12811

#12810: Extend RepartitioningPolicyTools::DefaultPolicy (proposed by peterrum; 
merged) https://github.com/dealii/dealii/pull/12810

#12809: Avoid lambda function to compile with Intel 18/19. (proposed by 
masterleinad; merged) https://github.com/dealii/dealii/pull/12809

#12808: Link step-82 into the tutorial page. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/12808

#12807: [WIP] Tutorial: Time-harmonic Maxwell solver with perfectly matched 
layer (proposed by tamiko) https://github.com/dealii/dealii/pull/12807

#12806: some step-49 follow-ups (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/12806

#12805: 9.3: cherry-picking #12533: step-79: Avoid using constructor which are 
incompatible to Intel 18. (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/12805

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

#12803: VectorizedArray: accept std::initializer_list (proposed by peterrum; 
merged) https://github.com/dealii/dealii/pull/12803

#12802: Better label documentation sections in sparse_matrix.h. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/12802

#12801: Minor adjustments to the IDA documentation. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/12801

#12800: Use an enum class in an internal namespace. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/12800

#12799: Minor edits to the ARKODE documentation. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/12799

#12798: Global coarsening: reset ghost state of internal vectors (proposed by 
peterrum; merged) https://github.com/dealii/dealii/pull/12798

#12797: hp Version of KellyErrorEstimator<1,spacedim> (proposed by gfcas; 
merged) https://github.com/dealii/dealii/pull/12797

#12796: Correct AssertMessage for FESeries::Legendre (proposed by gfcas; 
merged) https://github.com/dealii/dealii/pull/12796

#12795: Update p:d:SolutionTransfer code snippets (proposed by gfcas; merged) 
https://github.com/dealii/dealii/pull/12795

#12794: Simplify code in step-82 a little bit. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/12794

#12793: Add a missing instantiation. (proposed by bangerth) 
https://github.com/dealii/dealii/pull/12793

#12791: MappingQEulerian GMG bug (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/12791

#12448: Add tutorial program step-82 (proposed by dianeguignard; merged) 
https://github.com/dealii/dealii/pull/12448

#12319: Step 49 gmsh update (proposed by singima; merged) 
https://github.com/dealii/dealii/pull/12319


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

#12826: step-49 example gmsh input file doesn't work (opened) 
https://github.com/dealii/dealii/issues/12826

#12817: Compilation with 

[deal.II] deal.II Newsletter #185

2021-10-05 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

#12792: Add missing compress() to VectorTools::create_right_hand_side() 
(proposed by peterrum; merged) https://github.com/dealii/dealii/pull/12792

#12791: MappingQEulerian GMG bug (proposed by tjhei) 
https://github.com/dealii/dealii/pull/12791

#12790: Permit conversion of multi-level triangulations to simplices. (proposed 
by drwells; merged) https://github.com/dealii/dealii/pull/12790

#12789: Fix bug in ParameterHandler::parse_input for .prm (proposed by 
sebproell; merged) https://github.com/dealii/dealii/pull/12789

#12788: Test custom separators for Patterns::Map (proposed by sebproell; 
merged) https://github.com/dealii/dealii/pull/12788

#12787: Ignore any sections before 2411 in `GridIn::read_unv()` (proposed by 
vachan-potluri) https://github.com/dealii/dealii/pull/12787

#12786: Fix FEPointEvaluation for non-zero starting component (proposed by 
gassmoeller; merged) https://github.com/dealii/dealii/pull/12786

#12785: Mapping classes: Unify public/private properties (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/12785

#12784: Fix typo in ScratchData doc (proposed by gfcas; merged) 
https://github.com/dealii/dealii/pull/12784

#12783: Make FEEvaluationBase::apply_hanging_node_constraints protected 
(proposed by peterrum; merged) https://github.com/dealii/dealii/pull/12783

#12781: [WIP] Refactor FEEvaluationImplHangingNodes (proposed by peterrum) 
https://github.com/dealii/dealii/pull/12781


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

#12777: How to calculate solution at every cell center point? (closed) 
https://github.com/dealii/dealii/issues/12777

#12477: ParameterHandler::add_parameter fails for map> with 
custom separators (closed) https://github.com/dealii/dealii/issues/12477


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/615c7699.1c69fb81.5229.f989SMTPIN_ADDED_MISSING%40gmr-mx.google.com.


[deal.II] deal.II Newsletter #184

2021-09-28 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

#12779: Allow to disable fast matrix-free hanging-node algorithm (proposed by 
peterrum) https://github.com/dealii/dealii/pull/12779

#12778: Split up evaluation_template_factory (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/12778

#12776: Remove an IDE comment (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/12776

#12773: Support MappingCartesian in FEPointEvaluation (proposed by gassmoeller; 
merged) https://github.com/dealii/dealii/pull/12773

#12772: ShapeInfo: store both subface interpolation matrices (proposed by 
peterrum; merged) https://github.com/dealii/dealii/pull/12772

#12770: Fix two bibtex entries. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/12770


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

#12780: Reevaluate MF::AdditionalData::use_fast_hanging_node_algorithm (opened) 
https://github.com/dealii/dealii/issues/12780

#12777: How to calculate solution at every cell center point? (opened) 
https://github.com/dealii/dealii/issues/12777

#12775: No warning/error a non-conforming mesh with FE_NedelecSZ (opened) 
https://github.com/dealii/dealii/issues/12775

#12774: Trilinos: use Tpetra without enabling Epetra (opened) 
https://github.com/dealii/dealii/issues/12774


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/61533c1e.1c69fb81.f333d.8dcdSMTPIN_ADDED_MISSING%40gmr-mx.google.com.


[deal.II] deal.II Newsletter #183

2021-09-21 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

#12771: Add Hessian to FE_NedelecSZ (proposed by Sebastian-47) 
https://github.com/dealii/dealii/pull/12771

#12770: Fix two bibtex entries. (proposed by bangerth) 
https://github.com/dealii/dealii/pull/12770

#12769: matrix-free documentation (proposed by zjiaqi2018; merged) 
https://github.com/dealii/dealii/pull/12769

#12768: MatrixFree: Do not build inner face data if not requested (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/12768

#12767: HangingNodes: ignore artificial neighbors (proposed by peterrum; 
merged) https://github.com/dealii/dealii/pull/12767

#12766: [WIP] Make MGTwoLevelTransfer work for other VectorTypes (proposed by 
peterrum) https://github.com/dealii/dealii/pull/12766

#12765: Add a few references to the FE_Q_iso_Q1 element documentation. 
(proposed by bangerth; merged) https://github.com/dealii/dealii/pull/12765

#12764: Refactor hanging_nodes_internals.h (proposed by Rombur; merged) 
https://github.com/dealii/dealii/pull/12764

#12762: matrix-free documentation (proposed by zjiaqi2018) 
https://github.com/dealii/dealii/pull/12762

#12761: Instantiate MatrixTools::apply_boundary_values also for complex values 
(proposed by masterleinad) https://github.com/dealii/dealii/pull/12761

#12760: [WIP] Add SolverGCR (proposed by peterrum) 
https://github.com/dealii/dealii/pull/12760

#12759: Add FieldTransfer for the transfer of field with FE_Nothing (proposed 
by Rombur) https://github.com/dealii/dealii/pull/12759

#12755: Allow TrilinosPayload to use another TrilinosPayload as an exemplar 
operator (proposed by jppelteret; merged) 
https://github.com/dealii/dealii/pull/12755


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

#12763: MatrixFree setup of face data: Set up what the user requests (opened 
and closed) https://github.com/dealii/dealii/issues/12763

#12754: Using TrilinosWrappers::SolverCG in inverse_operator() (closed) 
https://github.com/dealii/dealii/issues/12754


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/614a01c3.1c69fb81.ce885.7c46SMTPIN_ADDED_MISSING%40gmr-mx.google.com.


[deal.II] deal.II Newsletter #182

2021-09-14 Thread 'Rene Gassmoeller' via deal.II User Group
Hello everyone!

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

#12758: Rename VECTOR to VectorType (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/12758

#12757: Add a CutFEM tutorial as step-85 (proposed by simonsticko) 
https://github.com/dealii/dealii/pull/12757

#12756: Add class NonMatching::FEValues (proposed by simonsticko) 
https://github.com/dealii/dealii/pull/12756

#12755: Allow TrilinosPayload to use another TrilinosPayload as an exemplar 
operator (proposed by jppelteret) https://github.com/dealii/dealii/pull/12755

#12753: Reduce run time of FEEvaluation tests with Hessians (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/12753

#12751: Bugfix: Invalid dofs on lines with similar FEs not correctly merged. 
(proposed by marcfehling; merged) https://github.com/dealii/dealii/pull/12751

#12750: Avoid warning about unused variable (proposed by kronbichler; merged) 
https://github.com/dealii/dealii/pull/12750

#12749: Consistently declare size_type in preconditioners derived from 
PreconditionRelaxation. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/12749

#12747: Fix unused-but-set-variable warnings (proposed by Rombur; merged) 
https://github.com/dealii/dealii/pull/12747

#12744: Hessians on general cells and faces (proposed by bergbauer; merged) 
https://github.com/dealii/dealii/pull/12744

#12692: Make Tensor::unroll() work with iterators. (proposed by drwells; 
merged) https://github.com/dealii/dealii/pull/12692

#12651: Extend ScratchData to return jumps and averages of FE functions on an 
interface (proposed by jppelteret; merged) 
https://github.com/dealii/dealii/pull/12651


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

#12754: Using TrilinosWrappers::SolverCG in inverse_operator() (opened) 
https://github.com/dealii/dealii/issues/12754

#12752: Bug: Triangulation::load()/save() with large output files (opened) 
https://github.com/dealii/dealii/issues/12752

#10401: Implement FEEvaluation::submit_hessian() (closed) 
https://github.com/dealii/dealii/issues/10401


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/6140c715.1c69fb81.cb6f9.5c8eSMTPIN_ADDED_MISSING%40gmr-mx.google.com.


  1   2   3   >