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 MGTransferGlobalCoarsening::interpolate_to_mg() that does not take 
DoFHandler (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/12858

#12855: fix step-49 geo file (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/12855

#12847: DataOut for pyramids: reorder at the end (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/12847

#12838: FE_Q_iso_Q1: varying subdivisions (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/12838

#12832: variable checkpointing fixes for >4GB files (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/12832

#12825: Do not communicate vertices automatically to p4est in debug mode. 
(proposed by marcfehling; merged) https://github.com/dealii/dealii/pull/12825


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

#12894: Support for Kokkos in deal.II (opened) 
https://github.com/dealii/dealii/issues/12894

#12873: MPI IO file write with >2GB individual writes (opened) 
https://github.com/dealii/dealii/issues/12873

#12870: Ordering of evaluation points when outputting data on 
higher-subdivision tets (opened) https://github.com/dealii/dealii/issues/12870

#12842: Ordering of vertices for wedges and pyramids (closed) 
https://github.com/dealii/dealii/issues/12842

#12826: step-49 example gmsh input file doesn't work (closed) 
https://github.com/dealii/dealii/issues/12826


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/617c1aa8.1c69fb81.960ae.9797SMTPIN_ADDED_MISSING%40gmr-mx.google.com.

Reply via email to