Hello everyone!

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

#4933: Use American English spelling. (proposed by bangerth) 
https://github.com/dealii/dealii/pull/4933

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

#4931: Use 'destroyed' instead of 'destructed'. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/4931

#4930: Fix a couple of more places in step-6. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/4930

#4928: Fix all deprecations in examples (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/4928

#4926: Fix integrators/laplacian_01 (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/4926

#4925: Simplify VectorMemory::Pointer. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/4925

#4924: Simplify code that uses variadic templates. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/4924

#4923: Avoid a warning with gcc 4.8. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/4923

#4922: Improve error message in hp::FECollection constructor (proposed by 
masterleinad; merged) https://github.com/dealii/dealii/pull/4922

#4919: Allows the CMake option DEAL_II_WITH_CXX11 to be enabled on Windows. 
(proposed by tulioligneul) https://github.com/dealii/dealii/pull/4919

#4918: Fixes possible error on "Vector<Number>::add(..)". (proposed by 
tulioligneul) https://github.com/dealii/dealii/pull/4918

#4917: Clean up the Timer CPU time calculations. (proposed by drwells) 
https://github.com/dealii/dealii/pull/4917

#4915: Fix compilation with GSL. (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/4915

#4913: Mark conversion constructors of SymmetricTensor and Tensor as 'explicit' 
(proposed by masterleinad; merged) https://github.com/dealii/dealii/pull/4913

#4912: Fix include directories for ADOLC (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/4912

#4911: Remove the check for sys/types.h. (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/4911

#4910: Fix a bug in CUDA matix-free when there is no constraint (proposed by 
Rombur; merged) https://github.com/dealii/dealii/pull/4910

#4909: Clean up hp::FECollection (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/4909

#4908: Introduce ::DoFHandler::get_fe_collection() and ::DoFHandler::get_fe() 
(proposed by masterleinad; merged) https://github.com/dealii/dealii/pull/4908

#4907: Remove DEAL_II_WRETURN_TYPE_CONST_QUALIFIER_BUG. (proposed by drwells; 
merged) https://github.com/dealii/dealii/pull/4907

#4906: Actually remove DEAL_II_EXPLICIT_CONSTRUCTOR_BUG. (proposed by drwells; 
merged) https://github.com/dealii/dealii/pull/4906

#4905: Timer mpi fixes (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/4905

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

#4903: Fix Assert with the correct number type (proposed by masterleinad; 
merged) https://github.com/dealii/dealii/pull/4903

#4902: move ConstantFunction and ZeroFunction to Functions:: namespace 
(proposed by davydden; merged) https://github.com/dealii/dealii/pull/4902

#4901: make an Assert in LA::distributed::Vector::compress_finish() less rigid 
(proposed by davydden; merged) https://github.com/dealii/dealii/pull/4901

#4900: fix a minor bug in MatrixFreeOperators::Base::vmult_interface_down() 
(proposed by davydden; merged) https://github.com/dealii/dealii/pull/4900

#4897: Fix a bug when using Tensor with CUDA. (proposed by Rombur; merged) 
https://github.com/dealii/dealii/pull/4897

#4896: Do not use dim3 for non-CUDA code (proposed by Rombur; merged) 
https://github.com/dealii/dealii/pull/4896

#4895: Remove double underscores from include guards (proposed by Rombur; 
merged) https://github.com/dealii/dealii/pull/4895

#4893: Generalisation of tensor and symmetric tensor functions (proposed by 
jppelteret; merged) https://github.com/dealii/dealii/pull/4893

#4892: Rename timer variables (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/4892

#4891: fix distributed GridTools::exchange_cell_data_to_ghost serialization ... 
(proposed by tjhei; merged) https://github.com/dealii/dealii/pull/4891

#4889: Follow up to #4888 fix regex substitution error (proposed by 
masterleinad; merged) https://github.com/dealii/dealii/pull/4889

#4888: Fix test output for integrators tests (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/4888

#4887: Fix tensor product matrix test case in float mode. (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/4887

#4885: CMake: Bugfix: Use correct cmake variable in external projects (proposed 
by tamiko; merged) https://github.com/dealii/dealii/pull/4885

#4884: Remove unused child (process) resource usage checks. (proposed by 
drwells; merged) https://github.com/dealii/dealii/pull/4884

#4882: Include correct headers for serialization of std::array (proposed by 
masterleinad; merged) https://github.com/dealii/dealii/pull/4882

#4881: Enable hp::DoFHandler on p::d::Triangulation and add tests (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/4881

#4877: cmake: fix intel compiler detection (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/4877

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

#4875: Tests: Guard a couple of tests with with_lapack=true (proposed by 
tamiko; merged) https://github.com/dealii/dealii/pull/4875

#4874: CMake: Second round of CUDA fixes (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/4874

#4873: Exchange active_fe_index information for p::d::Triangulation. (proposed 
by bangerth; merged) https://github.com/dealii/dealii/pull/4873

#4872: Use optional exchange of ghost data in DoFHandler::distribute_dofs() 
(proposed by bangerth; merged) https://github.com/dealii/dealii/pull/4872

#4870: minor fix of ConsecutiveControl (proposed by davydden; merged) 
https://github.com/dealii/dealii/pull/4870

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

#4868: Fix some #ifdef logic in the Timer class. (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/4868

#4866: Fix incorrect size in overlapping EPetra_Map to IndexSet (proposed by 
tjhei; merged) https://github.com/dealii/dealii/pull/4866

#4864: Update documentation to mention a published article. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/4864

#4863: Use the documented way to partition a p::s::Triangulation by hand. 
(proposed by bangerth; merged) https://github.com/dealii/dealii/pull/4863

#4862: Make noexcept for AssertNoThrow more explicit (proposed by masterleinad; 
merged) https://github.com/dealii/dealii/pull/4862

#4861: Update documentation of p::s::Triangulation. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/4861

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

#4858: Generalize GridTools::exchange_cell_data_to_ghosts() (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/4858

#4855: Express the ghost exchange of DoF indices using 
GridTools::exchange_cell_data_to_ghosts(). (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/4855

#4846: CMake: Refactor and fix CUDA configuration (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/4846

#4676: MGTransferBlockMatrixFree for LA::d::BlockVector (version 2) (proposed 
by davydden; merged) https://github.com/dealii/dealii/pull/4676


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

#4929: Replace DoFAccessor::get_fe() by DoFAccessor::get_finite_element() 
(opened) https://github.com/dealii/dealii/issues/4929

#4927: Check the CPU time calculations on Windows (opened) 
https://github.com/dealii/dealii/issues/4927

#4921: Boundary deprecation meta-tracker (opened) 
https://github.com/dealii/dealii/issues/4921

#4920: Avoid the `&v[0]` idiom (opened) 
https://github.com/dealii/dealii/issues/4920

#4916: Vector subscript out of range on "Vector<Number>::add(..)". (opened) 
https://github.com/dealii/dealii/issues/4916

#4914: Documentation for nanoflann (opened and closed) 
https://github.com/dealii/dealii/issues/4914

#4899: Possible invalid compiler flag set by CMake (clang only) (opened and 
closed) https://github.com/dealii/dealii/issues/4899

#4898: Advertise the CommonInputs class (related to DataPostprocessor) a bit 
better (opened and closed) https://github.com/dealii/dealii/issues/4898

#4894: Mark conversion constructors of SymmetricTensor and Tensor as 'explicit' 
(opened and closed) https://github.com/dealii/dealii/issues/4894

#4890: mpi/dof_handler_number_cache is failing (opened and closed) 
https://github.com/dealii/dealii/issues/4890

#4886: Bug in Tensor with CUDA (opened and closed) 
https://github.com/dealii/dealii/issues/4886

#4883: The new general container type (opened) 
https://github.com/dealii/dealii/issues/4883

#4880: New failing tests / new build failures (opened and closed) 
https://github.com/dealii/dealii/issues/4880

#4879: master is not compiling (opened and closed) 
https://github.com/dealii/dealii/issues/4879

#4878: recent intel compiler issues (opened) 
https://github.com/dealii/dealii/issues/4878

#4871: BlockVector vs MultiVector (opened) 
https://github.com/dealii/dealii/issues/4871

#4867: Timers are weirdly broken (opened) 
https://github.com/dealii/dealii/issues/4867

#4865: Be more efficient with creating a Trilinos Epetra_Map (opened) 
https://github.com/dealii/dealii/issues/4865

#4859: Closing the "dealii/experimental" repository (closed) 
https://github.com/dealii/dealii/issues/4859

#4835: lac/tensor_product_matrix_03.debug fails (closed) 
https://github.com/dealii/dealii/issues/4835

#4786: run CUDA build on Travis and run tests on tester (closed) 
https://github.com/dealii/dealii/issues/4786

#4770: Add generic `get_finite_element(unsigned int)` functions (closed) 
https://github.com/dealii/dealii/issues/4770

#4704: deal.II Hackathon meta tracker (closed) 
https://github.com/dealii/dealii/issues/4704

#4689: cuda does not work with cmake 3.8 (closed) 
https://github.com/dealii/dealii/issues/4689

#4638: hp::DoFHandler needs to exchange active_fe_index on ghost cells before 
distribute_dofs (closed) https://github.com/dealii/dealii/issues/4638

#4574: equivalent of MGTransferMatrixFree for 
LinearAlgebra::distributed::BlockVector (closed) 
https://github.com/dealii/dealii/issues/4574

#4478: ZeroFunction and ConstantFunction minor issues (closed) 
https://github.com/dealii/dealii/issues/4478

#4361: New improved CUDA functionality in CMake 3.8 (closed) 
https://github.com/dealii/dealii/issues/4361

#3331: cuda unit tests (closed) https://github.com/dealii/dealii/issues/3331

#3037: Require sm=35 or higher when using CUDA (closed) 
https://github.com/dealii/dealii/issues/3037

#2594: Compilation of CUDA applications (closed) 
https://github.com/dealii/dealii/issues/2594

#2023: Introduce ::DoFHandler::get_fe_collection() (closed) 
https://github.com/dealii/dealii/issues/2023


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