Hello everyone!

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

#8876: Fix setting host compiler (proposed by masterleinad) 
https://github.com/dealii/dealii/pull/8876

#8875: Bypass vector copy in MatrixFree::cell_loop with MPI (proposed by 
kronbichler) https://github.com/dealii/dealii/pull/8875

#8874: Fix some clang-tidy 9 findings (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/8874

#8872: Update the GPU matrix-free documentation (2) [WIP] (proposed by 
peterrum; merged) https://github.com/dealii/dealii/pull/8872

#8871: Update step-64 (proposed by peterrum) 
https://github.com/dealii/dealii/pull/8871

#8870: Require mpirun when requesting p4est in tests (proposed by masterleinad; 
merged) https://github.com/dealii/dealii/pull/8870

#8869: Update the description of the Nedelec element. (proposed by bangerth) 
https://github.com/dealii/dealii/pull/8869

#8868: Enable assert again (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/8868

#8867: Add changelog for #8861 (proposed by dougshidong; merged) 
https://github.com/dealii/dealii/pull/8867

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

#8865: Fix failing CUDA tests (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/8865

#8864: Change 'direction' of make_periodicity_constraint() to 'unsigned int'. 
(proposed by bangerth; merged) https://github.com/dealii/dealii/pull/8864

#8863: Add missing test output (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/8863

#8862: Fix a bug introduced in #8783 (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/8862

#8861: Fix Manifold get_new_point() (proposed by dougshidong; merged) 
https://github.com/dealii/dealii/pull/8861

#8860: Fix SolutionTransfer when coarsening from FE_Nothing (proposed by 
masterleinad; merged) https://github.com/dealii/dealii/pull/8860

#8859: Document direction parameter for periodic constraints (proposed by 
masterleinad; merged) https://github.com/dealii/dealii/pull/8859

#8858: add MatrixFree::get_cell_level_and_index() (proposed by jwitte08; 
merged) https://github.com/dealii/dealii/pull/8858

#8857: Extend TensorProductMatrixSymmetricSum (proposed by jwitte08; merged) 
https://github.com/dealii/dealii/pull/8857

#8856: Store Mapping in MatrixFree's MappingInfo (proposed by jwitte08; merged) 
https://github.com/dealii/dealii/pull/8856

#8855: Store 1D quadrature in ShapeInfo (proposed by jwitte08; merged) 
https://github.com/dealii/dealii/pull/8855

#8854: Compute shape_gradients/hessians_collocation in ShapeInfo (proposed by 
peterrum; merged) https://github.com/dealii/dealii/pull/8854

#8853: Modify method accessibility in ShapeInfo (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/8853

#8851: Restructure matrix_free/cuda_tensor_product_kernels.h [WIP] (proposed by 
peterrum) https://github.com/dealii/dealii/pull/8851

#8849: Make p:f:t:Utilities visible in Doxygen (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/8849

#8848: fix gcc 4.9 warning (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/8848

#8847: kinematics.h: fix always_inline (proposed by tjhei) 
https://github.com/dealii/dealii/pull/8847

#8846: Avoid dynamic_cast in ghost/artificial cell queries (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/8846

#8845: intel: disable const initializer warning (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/8845

#8844: Rewrite the introduction to the RT element. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/8844

#8843: Add test for MappingFEField (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/8843

#8842: Clean up more changelog entries. (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/8842

#8841: fix documentation in DerivativeApproximation (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/8841

#8840: Initialize n_colors in CUDAWrappers::MatrixFree::AdditionalData 
(proposed by peterrum; merged) https://github.com/dealii/dealii/pull/8840

#8839: Merge computation of values and gradients in the matrixfree CUDA code 
(proposed by peterrum; merged) https://github.com/dealii/dealii/pull/8839

#8838: Eliminate q_point from functor and other GPU functions (proposed by 
peterrum; merged) https://github.com/dealii/dealii/pull/8838

#8837: Update the GPU matrix-free documentation (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/8837

#8836: Inline functions because of bugs in hipcc (proposed by Rombur; merged) 
https://github.com/dealii/dealii/pull/8836

#8835: Fix boost problems with MSVC (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/8835

#8834: Add coarsening/refinement capabilities to p:f:t [WIP] (proposed by 
peterrum) https://github.com/dealii/dealii/pull/8834

#8833: Instantiate ConsensusAlgorithmSelector (proposed by masterleinad; 
merged) https://github.com/dealii/dealii/pull/8833

#8832: Remove std::bind from include (apart from documentation) (proposed by 
masterleinad; merged) https://github.com/dealii/dealii/pull/8832

#8831: Improve some changelog entries. (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/8831

#8830: Collate changelog entries (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/8830

#8829: add to documentation of get_coarse_mesh_description() (proposed by 
tjhei; merged) https://github.com/dealii/dealii/pull/8829

#8828: Assertion checks the wrong item size. (proposed by dougshidong; merged) 
https://github.com/dealii/dealii/pull/8828

#8827: Improve GridGenerator documentation in a few places. (proposed by 
drwells; merged) https://github.com/dealii/dealii/pull/8827

#8825: Remove std::bind from source (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/8825

#8823: Remove colon after @note. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/8823

#8822: Better document parallel::DistributedTriangulationBase. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/8822

#8821: Improve coding conventions (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/8821

#8818: Remove std::bind from hp (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/8818

#8817: Do not instantiate CellData for dim=0 (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/8817

#8815: instantiate TensorProductPolynomials for dim=0 (proposed by tjhei; 
merged) https://github.com/dealii/dealii/pull/8815

#8810: Change the storage type of MG copy indices to table (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/8810

#8805: Better document parallel::TriangulationBase. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/8805

#8802: Some bug fixed in p:f:t (proposed by peterrum; merged) 
https://github.com/dealii/dealii/pull/8802

#8783: Clean up compute_vertices_with_ghost_neighbors (proposed by peterrum; 
merged) https://github.com/dealii/dealii/pull/8783

#8772: Eliminate MPI all-to-all communication in MPI::Partitioner (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/8772

#8770: Document DataPostprocessor for the case of complex-valued solutions. 
(proposed by bangerth; merged) https://github.com/dealii/dealii/pull/8770

#8769: Make DataPostprocessor work for complex-valued vector-valued problems. 
(proposed by bangerth; merged) https://github.com/dealii/dealii/pull/8769

#8750: Create p:f:ConstructionData by a selected group of processes (proposed 
by peterrum; merged) https://github.com/dealii/dealii/pull/8750

#8739: add functions to access svd u and vt variables (proposed by MFraters; 
merged) https://github.com/dealii/dealii/pull/8739

#8728: Embed vector operations in MatrixFree cell loops (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/8728

#8713: Put implementation details of FEFaceEvaluation into separate file 
(proposed by kronbichler; merged) https://github.com/dealii/dealii/pull/8713


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

#8873: CMake configuration with CUDA/MPI code (opened) 
https://github.com/dealii/dealii/issues/8873

#8852: Performance tests (opened) https://github.com/dealii/dealii/issues/8852

#8850: Disagreement between MappingQ and MappingFEField using 
find_all_active_cells_around_point (opened) 
https://github.com/dealii/dealii/issues/8850

#8826: Does MGMatrixSimple fill in edge_out and edge_in correctly? (opened) 
https://github.com/dealii/dealii/issues/8826

#8820: Better document 'direction' of DoFTools::make_periodicity_constraints 
(opened and closed) https://github.com/dealii/dealii/issues/8820

#8814: Function<dim> default constructor in examples and intel compiler 
(closed) https://github.com/dealii/dealii/issues/8814

#8801: Definition of subdomain_id() on serial triangulation (closed) 
https://github.com/dealii/dealii/issues/8801

#8791: undefined references linker errors with intel 19.0.5 (closed) 
https://github.com/dealii/dealii/issues/8791

#8734: Treat periodic neighbors correctly in  
compute_vertices_with_ghost_neighbors (closed) 
https://github.com/dealii/dealii/issues/8734


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.
To view this discussion on the web visit 
https://groups.google.com/d/msgid/dealii/5d8e5c6b.1c69fb81.9f639.6a79SMTPIN_ADDED_MISSING%40gmr-mx.google.com.

Reply via email to