Hello everyone!

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

#5558: Avoid MPI calls in destructors with exceptions. (proposed by drwells) 
https://github.com/dealii/dealii/pull/5558

#5556: Remove Doxygen markers inside ArpackSolver::solve (proposed by Rombur; 
merged) https://github.com/dealii/dealii/pull/5556

#5555: Update function documentation. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/5555

#5554: Fix bug in JobIdentifier::base_name. (proposed by adamqc; merged) 
https://github.com/dealii/dealii/pull/5554

#5553: Improve documentation of Arpack (proposed by Rombur; merged) 
https://github.com/dealii/dealii/pull/5553

#5552: Small optimization. (proposed by simonpuchert) 
https://github.com/dealii/dealii/pull/5552

#5551: fixed history in ReductionControl::check() for final iteration (proposed 
by jodlbauer; merged) https://github.com/dealii/dealii/pull/5551

#5549: small fix of a template parameter in function orthogonal_equality 
(proposed by BenBrands; merged) https://github.com/dealii/dealii/pull/5549

#5548: Grammar update. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/5548

#5547: Make partition_zoltan the default choice for p::s::Triangulation 
(proposed by masterleinad) https://github.com/dealii/dealii/pull/5547

#5545: Move tests. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/5545

#5544: Minor cleanups to FE_FaceQ. (proposed by bangerth) 
https://github.com/dealii/dealii/pull/5544

#5543: Fix warning regarding unsigned int comparison (proposed by masterleinad; 
merged) https://github.com/dealii/dealii/pull/5543

#5542: Adding serialize for CellId (proposed by GivAlz; merged) 
https://github.com/dealii/dealii/pull/5542

#5541: More grammar fixes. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/5541

#5540: Change grammar of function documentation. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/5540

#5538: check Trilinos compress() argument (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/5538

#5537: Fix Wsign-compare warning (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/5537

#5536: Add sqmr (proposed by ikligge) https://github.com/dealii/dealii/pull/5536

#5535: Use uniform grammar in function documentation. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/5535

#5533: Tell users to build with ZOLTAN. (proposed by bangerth) 
https://github.com/dealii/dealii/pull/5533

#5532: Fix empty lines in subdomain_ids_parallel_08 output (proposed by 
masterleinad; merged) https://github.com/dealii/dealii/pull/5532

#5531: do not use base/revision.h in parameter_acceptor.h (proposed by 
davydden; merged) https://github.com/dealii/dealii/pull/5531

#5530: cmake: check trilinos optional modules at the very end (proposed by 
davydden) https://github.com/dealii/dealii/pull/5530

#5529: Relax tolerance in SphericalManifold (proposed by masterleinad) 
https://github.com/dealii/dealii/pull/5529

#5528: Allow non-interpolatory elements in FESystem for generalized supp.p. 
(proposed by tamiko; merged) https://github.com/dealii/dealii/pull/5528

#5527: Fix base/mpi_some_to_some_02 (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/5527

#5526: Adding serialize function to boundingbox class (proposed by GivAlz; 
merged) https://github.com/dealii/dealii/pull/5526

#5524: Fix communicate_active_fe_indices again (proposed by masterleinad; 
merged) https://github.com/dealii/dealii/pull/5524

#5523: Adding boost::serialize to bounding box, global bounding boxes to cache 
(proposed by GivAlz) https://github.com/dealii/dealii/pull/5523

#5522: Avoid undefined references in AD::NumberTraits (proposed by 
masterleinad; merged) https://github.com/dealii/dealii/pull/5522

#5521: Change partitioner for mpi/subdomain_ids_parallel_08 (proposed by 
masterleinad; merged) https://github.com/dealii/dealii/pull/5521

#5520: Make changelogs look more uniform. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/5520

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

#5514: Mesh partitioning with zoltan instead of metis. (proposed by niveshd; 
merged) https://github.com/dealii/dealii/pull/5514

#5512: Fix: solving issues of find active cell around point(cache) with points 
at the edge (proposed by GivAlz; merged) 
https://github.com/dealii/dealii/pull/5512

#5511: Restrict ARPACK tests to UMFPACK support (proposed by masterleinad; 
merged) https://github.com/dealii/dealii/pull/5511

#5509: Added random_value and random_point to tests.h (proposed by luca-heltai; 
merged) https://github.com/dealii/dealii/pull/5509

#5496: Test serialization of hp::DoFHandler (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/5496

#5491: Change the boundary value type to match the vector type. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/5491

#5478: Remove (empty) default constructor for ArrayView (proposed by 
masterleinad; merged) https://github.com/dealii/dealii/pull/5478

#5475: Generalize the numbering in the Cuthill-McKee algorithm. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/5475

#4577: Fix FE_Face elements for use in hp (proposed by simfeld; merged) 
https://github.com/dealii/dealii/pull/4577


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

#5557: Avoid MPI communication in TimerOutput::~TimerOutput if an exception is 
pending (opened) https://github.com/dealii/dealii/issues/5557

#5550: ReductionControl::check() does not log last iteration step to 
history_data (opened and closed) https://github.com/dealii/dealii/issues/5550

#5546: hp::dofhandler on p::d::tria with p::d::solutiontransfer  (opened) 
https://github.com/dealii/dealii/issues/5546

#5539: Use uniform grammar in function documentation. (opened) 
https://github.com/dealii/dealii/issues/5539

#5534: Switch parallel::shared::Triangulation default to Zoltan (opened) 
https://github.com/dealii/dealii/issues/5534

#5525: CMake: Implement macro to copy a file to some/all compiled test 
directories for one component (opened) 
https://github.com/dealii/dealii/issues/5525

#5515: parameter_acceptor rebuilds even when not touched (closed) 
https://github.com/dealii/dealii/issues/5515

#5438: VectorTools::interpolate still needs fixing for systems where parts have 
no support points (closed) https://github.com/dealii/dealii/issues/5438

#5417: Add complex-valued tests (closed) 
https://github.com/dealii/dealii/issues/5417

#5407: Make DoFRenumbering::Cuthill_McKee work with locally *relevant* DoFs in 
parallel (closed) https://github.com/dealii/dealii/issues/5407

#4684: Test serialization of hp::DoFHandler (closed) 
https://github.com/dealii/dealii/issues/4684


A list of all major changes since the last release can be found at 
https://www.dealii.org/developer/doxygen/deal.II/changes_after_8_5_0.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.
For more options, visit https://groups.google.com/d/optout.

Reply via email to