Hello everyone!

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

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

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

#4857: [WIP] Generalized support points / interpolation (proposed by tamiko) 
https://github.com/dealii/dealii/pull/4857

#4856: Clean up CUDA related files (proposed by masterleinad) 
https://github.com/dealii/dealii/pull/4856

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

#4854: minor extension of FullMatrix::cholesky documentation (proposed by 
davydden; merged) https://github.com/dealii/dealii/pull/4854

#4853: Moved Sacado product type header and Sacado tests (proposed by 
jppelteret; merged) https://github.com/dealii/dealii/pull/4853

#4852: IDAInterface (proposed by luca-heltai) 
https://github.com/dealii/dealii/pull/4852

#4849: Fix a markup problem. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/4849

#4848: Improve a couple of error messages that weren't quite clear. (proposed 
by bangerth; merged) https://github.com/dealii/dealii/pull/4848

#4847: Sundials detection. (proposed by luca-heltai; merged) 
https://github.com/dealii/dealii/pull/4847

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

#4845: [8.5.1] disable gcc warnings (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/4845

#4844: Add NANOFLANN to doxygen. (proposed by luca-heltai; merged) 
https://github.com/dealii/dealii/pull/4844

#4843: Simpify some code. (proposed by bangerth) 
https://github.com/dealii/dealii/pull/4843

#4842: enable CUDA in doxygen (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/4842

#4841: Bugfix: Make library compile with -DWITH_NANOFLANN=ON (proposed by 
tamiko; merged) https://github.com/dealii/dealii/pull/4841

#4840: [8.5.1] remove fallthrough warnings. (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/4840

#4839: [8.5.1] Increase the version number. (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/4839

#4838: [8.5.1] Boost patches for 8.5 (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/4838

#4837: Changelog entry for #4834 (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/4837

#4834: Deprecate constraint_and_return_value in favor of std::enable_if 
(proposed by masterleinad; merged) https://github.com/dealii/dealii/pull/4834

#4833: Avoid warnings related to the deprecation of types_are_equal (proposed 
by masterleinad; merged) https://github.com/dealii/dealii/pull/4833

#4832: [WIP] Further optimize MappingQGeneric for tensor product Quadrature 
(proposed by masterleinad) https://github.com/dealii/dealii/pull/4832

#4831: CMake: Bugfix: Remove SuiteSparse_config PIC test (proposed by tamiko; 
merged) https://github.com/dealii/dealii/pull/4831

#4830: Bugfix: Only run kdtree tests if nanoflann is configured (proposed by 
tamiko; merged) https://github.com/dealii/dealii/pull/4830

#4829: add mesh_loop GMG test (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/4829

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

#4827: Skip a type checking test on older boost versions. (proposed by drwells; 
merged) https://github.com/dealii/dealii/pull/4827

#4826: Make trilinos/precondition more robust (proposed by masterleinad; 
merged) https://github.com/dealii/dealii/pull/4826

#4825: KDTree class. (proposed by luca-heltai; merged) 
https://github.com/dealii/dealii/pull/4825

#4824: Add mesh_loop parallel test and improve MPILogInitAll (proposed by 
tjhei; merged) https://github.com/dealii/dealii/pull/4824

#4823: fix tests/meshworker/mesh_loop_* (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/4823

#4822: Better document what the ghost DoF index exchange does. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/4822

#4821: Reverse template arguments to 
parallel::GridTools::exchange_cell_data_to_ghosts() (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/4821

#4820: LogStream: Remove timestamp machinery and memory_consumption (proposed 
by tamiko; merged) https://github.com/dealii/dealii/pull/4820

#4819: Deprecate types_are_equal. (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/4819

#4817: Make DoFAccessor::set_active_fe_index() a 'const' function. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/4817

#4816: Document the default argument for the coefficient in the create_* 
functions (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/4816

#4815: Moved Sacado product type header and moved Sacado tests (proposed by 
jppelteret; merged) https://github.com/dealii/dealii/pull/4815

#4814: README.md: Make a lot of relative paths clickable. (proposed by tamiko; 
merged) https://github.com/dealii/dealii/pull/4814

#4813: LogStream: Remove log_cerr (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/4813

#4812: fix parpack unit test (proposed by davydden; merged) 
https://github.com/dealii/dealii/pull/4812

#4811: Restore create_* tests (proposed by masterleinad) 
https://github.com/dealii/dealii/pull/4811

#4810: Fix an assert: It should read "nullptr", not "null_ptr" (proposed by 
tamiko; merged) https://github.com/dealii/dealii/pull/4810

#4808: make compile without MPI (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/4808

#4807: clean up p4est::iterate (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/4807

#4806: Limit setting active_fe_indices to locally owned cells (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/4806

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

#4804: rewrite p4est::iterate (proposed by tjhei) 
https://github.com/dealii/dealii/pull/4804

#4803: Initialize tensor_product_quadrature in constructor (proposed by 
masterleinad; merged) https://github.com/dealii/dealii/pull/4803

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

#4798: Remove boundary usage (proposed by drwells) 
https://github.com/dealii/dealii/pull/4798

#4797: fix compilation (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/4797

#4795: Fix a bug in cuda matrix-free. (proposed by Rombur; merged) 
https://github.com/dealii/dealii/pull/4795

#4794: New find active cells around point. (proposed by luca-heltai; merged) 
https://github.com/dealii/dealii/pull/4794

#4793: Avoid warning in 64-bit mode. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/4793

#4792: Use correct data type also in 64-bit mode. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/4792

#4790: Fix #include guard name. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/4790

#4788: introduce GridTools::exchange_cell_data_to_ghosts (proposed by tjhei; 
merged) https://github.com/dealii/dealii/pull/4788

#4787: CMake: In case of C++14 support, check whether std::max/min support 
constexpr (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/4787

#4785: SymmetricTensor and Tensor class AD number compatibility (proposed by 
jppelteret; merged) https://github.com/dealii/dealii/pull/4785

#4784: lac/(consraints_c1_02|schur_complement): Modernize tests (proposed by 
tamiko; merged) https://github.com/dealii/dealii/pull/4784

#4783: CMake Adol-C detection (proposed by jppelteret; merged) 
https://github.com/dealii/dealii/pull/4783

#4782: base/anisotropic_1: Update forgotten test output (proposed by tamiko; 
merged) https://github.com/dealii/dealii/pull/4782

#4781: Avoid warnings in bundled muparser and boost (proposed by masterleinad; 
merged) https://github.com/dealii/dealii/pull/4781

#4780: tests: remove unnecessary includes (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/4780

#4779: trilinos as system includes, guard warnings (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/4779

#4778: Fix a data type (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/4778

#4777: Add additional functions to InvalidAccessor. (proposed by drwells; 
merged) https://github.com/dealii/dealii/pull/4777

#4776: Remove checks for various isnan functions. (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/4776

#4775: Mesh Loop. (proposed by luca-heltai; merged) 
https://github.com/dealii/dealii/pull/4775

#4774: Fix clang warning in grid/grid_in.cc (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/4774

#4773: Be careful for which cells and objects we allocate hp DoF indices. 
(proposed by bangerth; merged) https://github.com/dealii/dealii/pull/4773

#4772: [WIP] disable FE_Q_Hierarchical constraints (proposed by tjhei) 
https://github.com/dealii/dealii/pull/4772

#4771: Remove int2type and bool2type (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/4771

#4769: LogStream: Remove testing mode and float manipulation (proposed by 
tamiko; merged) https://github.com/dealii/dealii/pull/4769

#4766: Disable project_q_hierarchical_03 (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/4766

#4765: Disable two gcc 7.1.0 diagnostics for external includes (proposed by 
tamiko; merged) https://github.com/dealii/dealii/pull/4765

#4764: Remove an unused std::string. (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/4764

#4763: Remove unnecessary changelog. (proposed by kronbichler; merged) 
https://github.com/dealii/dealii/pull/4763

#4762: Allow the create_* functions to be called with nullptr coefficients 
(proposed by masterleinad; merged) https://github.com/dealii/dealii/pull/4762

#4761: DataOutBase: Do not modify precision of ostream (proposed by tamiko; 
merged) https://github.com/dealii/dealii/pull/4761

#4760: base/anisotropic_?: make tests more robust (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/4760

#4759: fix bug in tensorized MappingQGeneric (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/4759

#4758: Bugfix: Actually delete the right test... (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/4758

#4757: opencascade/(arclength_boundary_01|plane_intersection_01): remove tests 
(proposed by tamiko; merged) https://github.com/dealii/dealii/pull/4757

#4756: remove p::d::Triangulation::compute_level_vertices_with_ghost_neighbo... 
(proposed by tjhei; merged) https://github.com/dealii/dealii/pull/4756

#4755: mpi/locally_owned_dofs_per_subdomain_02: Add an output variant (proposed 
by tamiko; merged) https://github.com/dealii/dealii/pull/4755

#4754: rephrase changelog entry (proposed by tamiko) 
https://github.com/dealii/dealii/pull/4754

#4752: ShapeInfo<...>::reinit: add missing instantiations (proposed by tamiko; 
merged) https://github.com/dealii/dealii/pull/4752

#4751: add an output variant (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/4751

#4750: trilinos/solver_control_06: Add output variants (proposed by tamiko; 
merged) https://github.com/dealii/dealii/pull/4750

#4749: Reduce MeshWorker complexity by removing an undocumented preprocessor 
#define. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/4749

#4748: sharedtria/communicate_active_fe_indices_(01|02): add output variants 
(proposed by tamiko; merged) https://github.com/dealii/dealii/pull/4748

#4747: petsc/solver_03_precondition_parasails: Update forgotten test output 
(proposed by tamiko; merged) https://github.com/dealii/dealii/pull/4747

#4746: Fix markup in step-56 intro headings. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/4746

#4744: Restore true cell owners before setting up DoF data structures. 
(proposed by bangerth; merged) https://github.com/dealii/dealii/pull/4744

#4743: Fix creation of coverage information (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/4743

#4742: FEValuesViews::get_function_values_from_local_dof_values (proposed by 
luca-heltai; merged) https://github.com/dealii/dealii/pull/4742

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

#4740: constrained_linear_operator: use ConstraintMatrix iterators (proposed by 
tamiko; merged) https://github.com/dealii/dealii/pull/4740

#4739: Implement ConstraintMatrix::get_lines() (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/4739

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

#4736: Remove more memory consumption tests. (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/4736

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

#4733: Remove a function that is now no longer used. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/4733

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

#4731: Remove a check for GCC 4.4. (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/4731

#4730: Remove using 'deallog' in the linear solvers. (proposed by bangerth) 
https://github.com/dealii/dealii/pull/4730

#4729: [WIP] Add particle class (proposed by gassmoeller) 
https://github.com/dealii/dealii/pull/4729

#4728: add MGLevelObject::apply() (proposed by tjhei; merged) 
https://github.com/dealii/dealii/pull/4728

#4727: Remove the memory_consumption tests. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/4727

#4726: [WIP] FEValues::get_function_*_from_local_vector (proposed by 
luca-heltai) https://github.com/dealii/dealii/pull/4726

#4725: Update documentation about setting active FE indices. (proposed by 
bangerth; merged) https://github.com/dealii/dealii/pull/4725

#4724: Use check_solver_within_range in PETSc(serial) tests (proposed by 
masterleinad; merged) https://github.com/dealii/dealii/pull/4724

#4723: Break the Manifold interface for performance. (proposed by drwells) 
https://github.com/dealii/dealii/pull/4723

#4721: Use check_solver_within_range in Trilinos tests (proposed by 
masterleinad; merged) https://github.com/dealii/dealii/pull/4721

#4719: Check the numeric type to get an upper bound. (proposed by drwells; 
merged) https://github.com/dealii/dealii/pull/4719

#4718: Remove a usage of boost::bind. (proposed by drwells; merged) 
https://github.com/dealii/dealii/pull/4718

#4717: sharedtria/(tria_load|copy_tria): add output variants (proposed by 
tamiko; merged) https://github.com/dealii/dealii/pull/4717

#4716: petsc/solver_03_pre...: Use check solver_within_range macro (proposed by 
tamiko; merged) https://github.com/dealii/dealii/pull/4716

#4714: grid/mesh_3d_12: Increase precision and update output (proposed by 
tamiko; merged) https://github.com/dealii/dealii/pull/4714

#4713: add alternative test output for tests/pattern_tools_ (proposed by tjhei; 
merged) https://github.com/dealii/dealii/pull/4713

#4712: Exchange active_fe_index between processors. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/4712

#4711: Remove unused parameter warning (proposed by gassmoeller; merged) 
https://github.com/dealii/dealii/pull/4711

#4710: run tests/lac/utilities_01 only when we have PETSc+MPI (proposed by 
tjhei; merged) https://github.com/dealii/dealii/pull/4710

#4709: Change the number type of material_id and boundary_id (proposed by 
jppelteret; merged) https://github.com/dealii/dealii/pull/4709

#4708: Add test to show incompatibility between Sacado and FEValues interface 
(proposed by jppelteret) https://github.com/dealii/dealii/pull/4708

#4707: Replaced dealii::Vector with ArrayView in internal FEValues calls. 
(proposed by luca-heltai; merged) https://github.com/dealii/dealii/pull/4707

#4703: More DoFHandler policy cleanups. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/4703

#4702: Remove a largely unused iterator typedef. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/4702

#4701: Choose tensorized evaluation template instantiation at run time 
(proposed by masterleinad) https://github.com/dealii/dealii/pull/4701

#4699: Fix compilation of symmetric_tensor.inst for clang-4.0.0 (proposed by 
masterleinad; merged) https://github.com/dealii/dealii/pull/4699

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

#4697: Fix compilation with unity build. (proposed by kronbichler; merged) 
https://github.com/dealii/dealii/pull/4697

#4696: Fix Utilities::fixed_power for VectorizedArray. (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/4696

#4694: Restrict serial HDF5 tests to DEAL_II_WITH_MPI=OFF (proposed by 
masterleinad; merged) https://github.com/dealii/dealii/pull/4694

#4693: Move an iterator declaration that is now completely generic. (proposed 
by bangerth; merged) https://github.com/dealii/dealii/pull/4693

#4692: Introduce a move assignment operator for Quadrature (proposed by 
masterleinad; merged) https://github.com/dealii/dealii/pull/4692

#4690: Fix a compiler error by explicitly providing template arguments. 
(proposed by bangerth; merged) https://github.com/dealii/dealii/pull/4690

#4688: Fix a problem with old TBBs. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/4688

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

#4686: Avoid Assert in destructors. (proposed by bangerth; merged) 
https://github.com/dealii/dealii/pull/4686

#4683: Use the proper way to deal with std::unique_ptrs. (proposed by bangerth; 
merged) https://github.com/dealii/dealii/pull/4683

#4681: Fix test output for base/array_view_09 in release mode (proposed by 
masterleinad; merged) https://github.com/dealii/dealii/pull/4681

#4680: Generate vectorized data on 1D faces for MF::shape_info (proposed by 
kronbichler; merged) https://github.com/dealii/dealii/pull/4680

#4679: minor fix to DiagonalMatrix and add Utilities::Lac:: 
Lanczos_largest_eigenvalue (proposed by davydden; merged) 
https://github.com/dealii/dealii/pull/4679

#4678: extend pArpack interface to mode 1 and 2 (proposed by davydden; merged) 
https://github.com/dealii/dealii/pull/4678

#4673: Add computation of eigenvalues and eigenvectors for symmetric tensors 
(proposed by jppelteret; merged) https://github.com/dealii/dealii/pull/4673

#4668: Introduce Quadrature::is_tensor_product_flag (proposed by masterleinad; 
merged) https://github.com/dealii/dealii/pull/4668

#4666: Fix write_hdf5_parallel without MPI (proposed by masterleinad; merged) 
https://github.com/dealii/dealii/pull/4666

#4664: Use tensorized evaluation in MappingQGeneric  (proposed by masterleinad; 
merged) https://github.com/dealii/dealii/pull/4664

#4609: Deprecate FilteredMatrix (proposed by tamiko; merged) 
https://github.com/dealii/dealii/pull/4609


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

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

#4851: 8.5.1 remaining tasks (opened and closed) 
https://github.com/dealii/dealii/issues/4851

#4850: Update readme.html for Nanoflann and ADOL-C and SUNDIALS (opened) 
https://github.com/dealii/dealii/issues/4850

#4836: The 8.5.1 bugfix release (opened) 
https://github.com/dealii/dealii/issues/4836

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

#4818: Introduce AdditionType, SumType and family to tensor classes (opened) 
https://github.com/dealii/dealii/issues/4818

#4809: New failures in matrix creators (opened and closed) 
https://github.com/dealii/dealii/issues/4809

#4802: Non-static class member "tensor_product_quadrature" is not initialized 
in this constructor nor in any functions that it calls. (opened and closed) 
https://github.com/dealii/dealii/issues/4802

#4800: Update documentation for Boundary classes. (opened) 
https://github.com/dealii/dealii/issues/4800

#4799: Deprecate all Boundary classes. (opened) 
https://github.com/dealii/dealii/issues/4799

#4796: Rename p4est::functions<dim>::iterate (opened and closed) 
https://github.com/dealii/dealii/issues/4796

#4791: Fix 64bit indices build (opened and closed) 
https://github.com/dealii/dealii/issues/4791

#4789: Replace p::d::Triangulation::fill_vertices_with_ghost_neighbors() by a 
function that returns the result by value (opened and closed) 
https://github.com/dealii/dealii/issues/4789

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

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

#4768: Compile tests in tests/fail/ (opened) 
https://github.com/dealii/dealii/issues/4768

#4767: Constraints bug in FE_Q_Hierarchical (opened) 
https://github.com/dealii/dealii/issues/4767

#4753: Proposal for MeshLoop (opened and closed) 
https://github.com/dealii/dealii/issues/4753

#4745: Link errors with suitesparse_config (opened and closed) 
https://github.com/dealii/dealii/issues/4745

#4737: hp::DoFHandler::vertex_dof_offsets has the wrong type (opened and 
closed) https://github.com/dealii/dealii/issues/4737

#4735: Simplify hp::DoFHandler::reserve_space (opened and closed) 
https://github.com/dealii/dealii/issues/4735

#4722: Linker errors in tests on MacOS  (opened) 
https://github.com/dealii/dealii/issues/4722

#4720: tests/no_cells_01 and tests/hp_no_cells_01 do something illegal (opened) 
https://github.com/dealii/dealii/issues/4720

#4715: replace check_solve by check_solver_within_range (opened) 
https://github.com/dealii/dealii/issues/4715

#4706: FEValues for General types. (opened) 
https://github.com/dealii/dealii/issues/4706

#4705: lac/utilities_01 is failing for complex PETSc (opened and closed) 
https://github.com/dealii/dealii/issues/4705

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

#4700: arpack/step-36_parpack_mf_02 failing (opened and closed) 
https://github.com/dealii/dealii/issues/4700

#4695: Partially specialize for Patch<0,spacedim> (opened) 
https://github.com/dealii/dealii/issues/4695

#4691: pattern_tools_01 and _06 fail (opened and closed) 
https://github.com/dealii/dealii/issues/4691

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

#4685: Add move assignment operator to class Quadrature (opened and closed) 
https://github.com/dealii/dealii/issues/4685

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

#4682: Master does not compile with cuda (opened and closed) 
https://github.com/dealii/dealii/issues/4682

#4672: Change type for boundary_id and material_id (closed) 
https://github.com/dealii/dealii/issues/4672

#4661: cannot compile with gcc-5.4 (closed) 
https://github.com/dealii/dealii/issues/4661

#4627: p::d::Triangulation::fill_level_vertices_with_ghost_neighbors() is 
unused (closed) https://github.com/dealii/dealii/issues/4627

#4598: Use tensorized evaluation for main work in MappingQGeneric (closed) 
https://github.com/dealii/dealii/issues/4598

#4392: Precompiled headers and unity builds (closed) 
https://github.com/dealii/dealii/issues/4392

#4331: Use larger search paths for MPI (closed) 
https://github.com/dealii/dealii/issues/4331

#4237: dealii::Function versus lambda closures and std::function (closed) 
https://github.com/dealii/dealii/issues/4237

#308: Extend DataOutBase to also accept 0-dimensional patches (closed) 
https://github.com/dealii/dealii/issues/308


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