From: Matthias Maier Date: Tue, 14 May 2019 13:46:30 +0000 (-0500) Subject: Remove now obsolete files. X-Git-Tag: v9.1.0-rc1~5^2 X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=refs%2Fpull%2F8163%2Fhead;p=dealii.git Remove now obsolete files. --- diff --git a/doc/news/changes/incompatibilities/20180509Bangerth b/doc/news/changes/incompatibilities/20180509Bangerth deleted file mode 100644 index 19e8edb02a..0000000000 --- a/doc/news/changes/incompatibilities/20180509Bangerth +++ /dev/null @@ -1,7 +0,0 @@ -Changed: The PolynomialSpace::compute_index() and -PolynomialsP::directional_degree() functions used to return their -information through an array that they received as a reference -argument. Instead, they now return a `std::array` -by value. -
-(Wolfgang Bangerth, 2018/05/09) diff --git a/doc/news/changes/incompatibilities/20180516Wells b/doc/news/changes/incompatibilities/20180516Wells deleted file mode 100644 index c5f9b69560..0000000000 --- a/doc/news/changes/incompatibilities/20180516Wells +++ /dev/null @@ -1,7 +0,0 @@ -Changed: The OpenCASCADE Manifold classes with names ending in Boundary (i.e., -NormalProjectionBoundary, DirectionalProjectionBoundary, and -NormalToMeshProjectionBoundary) have been deprecated in favor of renamed classes -ending in Manifold (i.e., NormalProjectionManifold, -DirectionalProjectionManifold, and NormalToMeshProjectionManifold). -
-(David Wells, 2018/05/16) diff --git a/doc/news/changes/incompatibilities/20180525Maier b/doc/news/changes/incompatibilities/20180525Maier deleted file mode 100644 index 50eb7f450e..0000000000 --- a/doc/news/changes/incompatibilities/20180525Maier +++ /dev/null @@ -1,9 +0,0 @@ -Changed: The AffineConstraints object (formerly ConstraintMatrix) gained a -template parameter for the underlying storage type. In order to facilitate -this change, the interface for AffineConstraints has become more strict: In -particular, the AffineConstraints::distribute_local_to_global(), -AffineConstraints::add_entries_local_to_global(), and other functions now -require that all matrix and vector arguments have the same matching number -type as the AffineConstraints object. -
-(Matthias Maier, 2018/05/25) diff --git a/doc/news/changes/incompatibilities/20180525Maier-2 b/doc/news/changes/incompatibilities/20180525Maier-2 deleted file mode 100644 index 92dfc11c80..0000000000 --- a/doc/news/changes/incompatibilities/20180525Maier-2 +++ /dev/null @@ -1,8 +0,0 @@ -Changed: MatrixCreator::create_mass_matrix and -MatrixCreator::create_boundary_mass_matrix that had mixed number type (real -valued for the matrix and complex valued for vectors) have been changed to -support complex number types uniformly. This implies that now all -underlying number types of matrix, vectors and AffineConstraint objects -have to match; mixed variants are no longer supported. -
-(Matthias Maier, 2018/05/25) diff --git a/doc/news/changes/incompatibilities/20180720Fehling b/doc/news/changes/incompatibilities/20180720Fehling deleted file mode 100644 index 98d1ebd976..0000000000 --- a/doc/news/changes/incompatibilities/20180720Fehling +++ /dev/null @@ -1,16 +0,0 @@ -Changes: The data transfer interface of the class -`parallel::distributed::Triangulation` now requires different kinds of -callback functions. `register_data_attach()` now takes -`std::function(cell_iterator &, CellStatus)>`, -which returns the buffer of the packed data. `notify_ready_to_unpack()` -requires `std::function::const_iterator &>`, where -the last argument describes an iterator range, from which the callback -function is allowed to read. -
-Further, the `register_data_attach()` function now requires a boolean -argument `returns_variable_size_data`, which denotes if the registered -pack_callback function interacts with the fixed size (`=false`) or -variable size (`=true`) buffer for data transfer. -
-(Marc Fehling, 2018/07/20) diff --git a/doc/news/changes/incompatibilities/20180807DanielArndt b/doc/news/changes/incompatibilities/20180807DanielArndt deleted file mode 100644 index 7e9ff27665..0000000000 --- a/doc/news/changes/incompatibilities/20180807DanielArndt +++ /dev/null @@ -1,4 +0,0 @@ -Changed: Triangulation::create_triangulation() doesn't allow to set a boundary -id different from numbers::internal_face_boundary_id for internal faces anymore. -
-(Daniel Arndt, 2018/08/07) diff --git a/doc/news/changes/incompatibilities/20181011Fehling b/doc/news/changes/incompatibilities/20181011Fehling deleted file mode 100644 index 4c8eb0100b..0000000000 --- a/doc/news/changes/incompatibilities/20181011Fehling +++ /dev/null @@ -1,5 +0,0 @@ -Deprecated: FiniteElement::compare_for_face_domination() has been -deprecated and will be replaced by the more versatile function -FiniteElement::compare_for_domination(). -
-(Marc Fehling, 2018/10/11) diff --git a/doc/news/changes/incompatibilities/20181026DanielArndt b/doc/news/changes/incompatibilities/20181026DanielArndt deleted file mode 100644 index 7a45d4d4a6..0000000000 --- a/doc/news/changes/incompatibilities/20181026DanielArndt +++ /dev/null @@ -1,5 +0,0 @@ -Changed: Time is described by a real-valued scalar in Function, TensorFunction, -ConstantTensorFunction and ZeroTensorFunction, i.e. all of them derive from -FunctionTime with a real-valued scalar template parameter. -
-(Daniel Arndt, 2018/10/26) diff --git a/doc/news/changes/incompatibilities/20181027DavidWells b/doc/news/changes/incompatibilities/20181027DavidWells deleted file mode 100644 index d0e909b2e0..0000000000 --- a/doc/news/changes/incompatibilities/20181027DavidWells +++ /dev/null @@ -1,7 +0,0 @@ -Deprecated: deal.II's NetCDF bindings have been deprecated. The present set of -bindings are incompatible with recent releases of NetCDF and, at the present -time, no one has volunteered to either maintain or upgrade our interface. The -bindings will be removed in a future version if no one steps forward to update -the bindings. -
-(David Wells, 2018/10/27) diff --git a/doc/news/changes/incompatibilities/20181102DanielArndt b/doc/news/changes/incompatibilities/20181102DanielArndt deleted file mode 100644 index f4a6992221..0000000000 --- a/doc/news/changes/incompatibilities/20181102DanielArndt +++ /dev/null @@ -1,5 +0,0 @@ -Changed: The constructor for Subscriptor requires providing a pointer to a boolean -that can be used to signal validity of the object pointed to by the subscribing -object. -
-(Daniel Arndt, 2018/11/02) diff --git a/doc/news/changes/incompatibilities/20181112DanielArndt b/doc/news/changes/incompatibilities/20181112DanielArndt deleted file mode 100644 index 398177d5eb..0000000000 --- a/doc/news/changes/incompatibilities/20181112DanielArndt +++ /dev/null @@ -1,8 +0,0 @@ -Changed: Subscriptor::subscribe cannot be called with rvalue references anymore. -In particular, temporary string literals cannot be used as argument. Storing -string literals with the same content at the same memory location is -implementation defined and cannot be relied upon. On the other hand, the -subscriber strings are not compared by their memory address anymore but by their -actual content. -
-(Daniel Arndt, 2018/11/12) diff --git a/doc/news/changes/incompatibilities/20181130DavidWells b/doc/news/changes/incompatibilities/20181130DavidWells deleted file mode 100644 index ec05805b74..0000000000 --- a/doc/news/changes/incompatibilities/20181130DavidWells +++ /dev/null @@ -1,5 +0,0 @@ -Changed: The particle MPI datatype macro PARTICLE_INDEX_MPI_TYPE is -now properly namespaced: its new name is -DEAL_II_PARTICLE_INDEX_MPI_TYPE. -
-(David Wells, 2018/11/30) diff --git a/doc/news/changes/incompatibilities/20190111DavidWells b/doc/news/changes/incompatibilities/20190111DavidWells deleted file mode 100644 index 9c338e4a1b..0000000000 --- a/doc/news/changes/incompatibilities/20190111DavidWells +++ /dev/null @@ -1,5 +0,0 @@ -Changed: The class VectorView has been removed. The suggested replacements are -to either use an ArrayView, a BlockVector, or to copy the relevant subset into a -Vector. -
-(David Wells, 2019/01/11) diff --git a/doc/news/changes/incompatibilities/20190121DavidWells b/doc/news/changes/incompatibilities/20190121DavidWells deleted file mode 100644 index 1edbce7a12..0000000000 --- a/doc/news/changes/incompatibilities/20190121DavidWells +++ /dev/null @@ -1,6 +0,0 @@ -Changed: VectorSlice has been deprecated in favor of the more general ArrayView -class. All public interfaces now take ArrayView arguments instead of VectorSlice -arguments. Since VectorSlice now inherits from ArrayView this should be -compatible with the overwhelming majority of use cases. -
-(David Wells, 2019/01/21) diff --git a/doc/news/changes/incompatibilities/20190205Maier b/doc/news/changes/incompatibilities/20190205Maier deleted file mode 100644 index 2078681358..0000000000 --- a/doc/news/changes/incompatibilities/20190205Maier +++ /dev/null @@ -1,5 +0,0 @@ -Changed: The "debug" and "release" targets that are created by the -DEAL_II_INVOKE_AUTOPILOT() macro no longer automatically rebuild the -project. -
-(Matthias Maier, 2019/02/05) diff --git a/doc/news/changes/incompatibilities/20190320DanielArndt b/doc/news/changes/incompatibilities/20190320DanielArndt deleted file mode 100644 index e4cc41414b..0000000000 --- a/doc/news/changes/incompatibilities/20190320DanielArndt +++ /dev/null @@ -1,4 +0,0 @@ -Removed: The IndexSet instantiations for FEValues::get_function_values() -and DataOut_DoFData::add_data_vector() have been removed. -
-(Daniel Arndt, 2019/03/20) diff --git a/doc/news/changes/incompatibilities/20190408Fehling b/doc/news/changes/incompatibilities/20190408Fehling deleted file mode 100644 index 15e2f27e55..0000000000 --- a/doc/news/changes/incompatibilities/20190408Fehling +++ /dev/null @@ -1,6 +0,0 @@ -Changed: Tasks of member function -hp::FECollection::find_face_dominating_fe_in_subset() are now divided -into two functions hp::FECollection::find_common_subspace() -and hp::FECollection::find_dominated_fe(). -
-(Marc Fehling, 2019/04/08) diff --git a/doc/news/changes/major/20180420NiveshD b/doc/news/changes/major/20180420NiveshD deleted file mode 100644 index 1d8a7479c6..0000000000 --- a/doc/news/changes/major/20180420NiveshD +++ /dev/null @@ -1,9 +0,0 @@ -New: The new class ColorEnriched::Helper constructs an hp::FECollection, a -collection of finite element objects used by hp::DoFHandler, in a domain -with multiple, possibly overlapping, sub-domains with individual -enrichment functions. Note that the overlapping regions may have -multiple enrichment functions associated with them. This is implemented -using a general constructor of FE_Enriched which allows different -enrichment functions. -
-(Nivesh Dommaraju, Denis Davydov, 2018/04/20) diff --git a/doc/news/changes/major/20180428RossKynch b/doc/news/changes/major/20180428RossKynch deleted file mode 100644 index 0d86c7d762..0000000000 --- a/doc/news/changes/major/20180428RossKynch +++ /dev/null @@ -1,8 +0,0 @@ -New: FE_NedelecSZ is a new H(curl)-conforming element which overcomes the sign conflict problem -which can be encountered for Nedelec elements on hexahedral meshes. This is an implementation of -the method described in the PhD thesis of Sabine Zaglmayr and should be considered over the -FE_Nedelec element where meshes with non-standard orientation are used. Note that not all -functionality (e.g. Hessians), has been implemented for this element. -
-(Ross Kynch, 2018/04/28) - diff --git a/doc/news/changes/major/20180524MatthiasMaierDanielArndt b/doc/news/changes/major/20180524MatthiasMaierDanielArndt deleted file mode 100644 index f76fada44e..0000000000 --- a/doc/news/changes/major/20180524MatthiasMaierDanielArndt +++ /dev/null @@ -1,3 +0,0 @@ -Changed: clang-format replaces astyle as source code formatting tool. -
-(Matthias Maier, Daniel Arndt, 2018/05/24) diff --git a/doc/news/changes/major/20180525Bangerth b/doc/news/changes/major/20180525Bangerth deleted file mode 100644 index 3144af4301..0000000000 --- a/doc/news/changes/major/20180525Bangerth +++ /dev/null @@ -1,6 +0,0 @@ -New: The introduction to step-6 has been completely rewritten. It -previously mentioned only the bare minimum about what this important -tutorial program actually does. It now gives a much broader overview -of why we use adaptive meshes and how this is achieved in practice. -
-(Wolfgang Bangerth, 2018/05/25) diff --git a/doc/news/changes/major/20180531MatthiasMaier b/doc/news/changes/major/20180531MatthiasMaier deleted file mode 100644 index 05476ca921..0000000000 --- a/doc/news/changes/major/20180531MatthiasMaier +++ /dev/null @@ -1,7 +0,0 @@ -Changed: The ConstraintMatrix class has been renamed to AffineConstraints. -Further, AffineConstraints gained a template parameter for the underlying -storage type. This in particular enables the definition of complex-valued -constraints (for example, complex-valued Dirichlet boundary conditions, or -periodic boundary conditions with an additional phase shift). -
-(Matthias Maier, Daniel Arndt, David Wells, 2018/05/31) diff --git a/doc/news/changes/major/20180704DavidWells b/doc/news/changes/major/20180704DavidWells deleted file mode 100644 index ebd849d437..0000000000 --- a/doc/news/changes/major/20180704DavidWells +++ /dev/null @@ -1,6 +0,0 @@ -New: A new function GridGenerator::channel_with_cylinder has been added. This -function generates a grid corresponding to the classic flow past a cylinder test -problem, and uses manifolds to blend between the description of the cylinder and -the Cartesian bulk geometry. -
-(David Wells, 2018/07/04) diff --git a/doc/news/changes/major/20180709Harper b/doc/news/changes/major/20180709Harper deleted file mode 100644 index 380ed6877c..0000000000 --- a/doc/news/changes/major/20180709Harper +++ /dev/null @@ -1,8 +0,0 @@ -New: FE_BernardiRaugel is the implementation of an element developed by Christine Bernardi and -Genevieve Raugel in the 1985 Mathematics of Computation paper. The Bernardi-Raugel element is an -enrichment of the P1-P0 element for Stokes problems by the addition of edge-based quadratic -bubble functions. The original description is for simplicial meshes, but this implementation is -for quadrilateral and hexahedral meshes. The BR1-P0 pair is LBB stable for Stokes problems. Due -to the edge-based bubble functions, features such as hanging nodes are not supported. -
-(Graham Harper, 07/09/2018) diff --git a/doc/news/changes/major/20180811DavidWells b/doc/news/changes/major/20180811DavidWells deleted file mode 100644 index c6ec70b3af..0000000000 --- a/doc/news/changes/major/20180811DavidWells +++ /dev/null @@ -1,4 +0,0 @@ -Improved: GridGenerator::extrude_triangulation can now optionally extrude manifold -ids. -
-(David Wells, 2018/08/11) diff --git a/doc/news/changes/major/20180815Fehling b/doc/news/changes/major/20180815Fehling deleted file mode 100644 index d93218212e..0000000000 --- a/doc/news/changes/major/20180815Fehling +++ /dev/null @@ -1,6 +0,0 @@ -New: The parallel::distributed::SolutionTransfer class is now capable -of transferring data that has been associated with a hp::DoFHandler -object. See the class documentation of the former on how to use this -new functionality. -
-(Marc Fehling, 2018/08/15) diff --git a/doc/news/changes/major/20180827Jean-PaulPelteret b/doc/news/changes/major/20180827Jean-PaulPelteret deleted file mode 100644 index 6ff2bb4b71..0000000000 --- a/doc/news/changes/major/20180827Jean-PaulPelteret +++ /dev/null @@ -1,6 +0,0 @@ -New: A new class Differentiation::AD::EnergyFunctional has been -added to help implement (incremental) variational formulations using automatic -differentiation. In particular, this class is designed to compute the finite -element residuals and their linearizations. -
-(Jean-Paul Pelteret, 2018/08/27) diff --git a/doc/news/changes/major/20180831Fehling b/doc/news/changes/major/20180831Fehling deleted file mode 100644 index 70a8b6da6b..0000000000 --- a/doc/news/changes/major/20180831Fehling +++ /dev/null @@ -1,7 +0,0 @@ -Changed: hp::DoFHandler::distribute_dofs() called on -parallel::distributed::Triangulation objects now assigns exactly -one index for each degree of freedom located on interfaces with -ghost cells. Previously, those degrees of freedom were assigned -indices by each adjacent subdomain. -
-(Marc Fehling, 2018/08/31) diff --git a/doc/news/changes/major/20180930Jean-PaulPelteret b/doc/news/changes/major/20180930Jean-PaulPelteret deleted file mode 100644 index 3fbe9844e1..0000000000 --- a/doc/news/changes/major/20180930Jean-PaulPelteret +++ /dev/null @@ -1,5 +0,0 @@ -New: A new class Differentiation::AD::ResidualLinearization has been -added to help compute the linearization of a residual vector defined on the -level of a cell (a finite element residual), or for local nonlinear equations. -
-(Jean-Paul Pelteret, 2018/09/30) diff --git a/doc/news/changes/major/20181011Fehling b/doc/news/changes/major/20181011Fehling deleted file mode 100644 index 8ab781adee..0000000000 --- a/doc/news/changes/major/20181011Fehling +++ /dev/null @@ -1,5 +0,0 @@ -New: Function FiniteElement::compare_for_domination() inspects two -FiniteElement objects upon FiniteElementDomination, and uses a codim -parameter that determines in which subspace we actually compare them. -
-(Marc Fehling, 2018/10/11) diff --git a/doc/news/changes/major/20181015Fehling b/doc/news/changes/major/20181015Fehling deleted file mode 100644 index 7b4e7f5d3d..0000000000 --- a/doc/news/changes/major/20181015Fehling +++ /dev/null @@ -1,8 +0,0 @@ -Changed: hp::DoFHandler now automatically sets active_fe_indices -on cells that will be refined and coarsened whenever a Triangulation or -parallel::shared::Triangulation is used. Upon refinement, the -active_fe_index will be passed on to the children. For coarsening, the -parent's active_fe_index will be determined from its former children -using the FiniteElementDomination logic. -
-(Marc Fehling, 2018/10/15) diff --git a/doc/news/changes/major/20190108DanielGarcia-Sanchez b/doc/news/changes/major/20190108DanielGarcia-Sanchez deleted file mode 100644 index 587aba4af7..0000000000 --- a/doc/news/changes/major/20190108DanielGarcia-Sanchez +++ /dev/null @@ -1,7 +0,0 @@ -New: A new HDF5 interface has been added. The Hierarchical Data Format (HDF) is -a cross platform and a high I/O performance format designed to store large -amounts of data. It supports serial and MPI I/O access. The deal.II's HDF5 -interface can be used to write and read data, such the results of a simulation, -in a HDF5 file. -
-(Daniel Garcia-Sanchez, 2019/01/09) diff --git a/doc/news/changes/major/20190127Fehling b/doc/news/changes/major/20190127Fehling deleted file mode 100644 index 74c4c55f90..0000000000 --- a/doc/news/changes/major/20190127Fehling +++ /dev/null @@ -1,10 +0,0 @@ -Changed: Class hp::DoFHandler now transfers the active_fe_index of each -cell automatically when refining/coarsening a Triangulation, -parallel::shared::Triangulation, or -parallel::distributed::Triangulation. However, serialization of a -parallel::distributed::Triangulation still requires a user to -explicitly call the functions -hp::DoFHandler::prepare_for_serialization_of_active_fe_indices() and -hp::DoFHandler::deserialize_active_fe_indices(). -
-(Marc Fehling, 2019/01/27) diff --git a/doc/news/changes/major/20190130ginkgo-developers b/doc/news/changes/major/20190130ginkgo-developers deleted file mode 100644 index 646f6b3d14..0000000000 --- a/doc/news/changes/major/20190130ginkgo-developers +++ /dev/null @@ -1,7 +0,0 @@ -New: Support for Ginkgo, a high-performance numerical linear algebra library -has been added. Ginkgo provides advanced highly optimized linear solvers, -matrix formats and an abstraction to easily create linear operators on both -the cpu and the gpu. The deal.II's Ginkgo interface can currently be used to -solve linear systems using Krylov solvers with the cuda and OpenMP paradigms. -
-(Ginkgo developers, 2019/01/30) diff --git a/doc/news/changes/major/20190208MatthiasMaier b/doc/news/changes/major/20190208MatthiasMaier deleted file mode 100644 index 2131b88f99..0000000000 --- a/doc/news/changes/major/20190208MatthiasMaier +++ /dev/null @@ -1,4 +0,0 @@ -Improved: The preconditioner and solver setup in step-20 has been rewritten -to highlight the new LinearOperator and PackagedOperation classes. -
-(Matthias Maier, 2019/02/08) diff --git a/doc/news/changes/major/20190220Jean-PaulPelteret b/doc/news/changes/major/20190220Jean-PaulPelteret deleted file mode 100644 index 3a0e37fe0d..0000000000 --- a/doc/news/changes/major/20190220Jean-PaulPelteret +++ /dev/null @@ -1,9 +0,0 @@ -New: A new class Differentiation::AD::ScalarFunction has been -added to help implement point-wise scalar functions using automatic -differentiation. In particular, this class is designed to compute the -gradient and Hessian of a scalar function that is parameterized in -terms of scalar, vector, and tensor arguments. One example of its use -would be to compute the derivatives of a multi-field constitutive law -that is expressed in terms of an energy function. -
-(Jean-Paul Pelteret, 2019/02/20) diff --git a/doc/news/changes/major/20190318Fehling b/doc/news/changes/major/20190318Fehling deleted file mode 100644 index 49e67ca780..0000000000 --- a/doc/news/changes/major/20190318Fehling +++ /dev/null @@ -1,4 +0,0 @@ -New: Triangulation::execute_coarsening_and_refinement() now also performs -p-coarsening and p-refinement on all attached hp::DoFHandler objects. -
-(Marc Fehling, 2019/03/18) diff --git a/doc/news/changes/major/20190321Jean-PaulPelteret b/doc/news/changes/major/20190321Jean-PaulPelteret deleted file mode 100644 index 80e70e9e66..0000000000 --- a/doc/news/changes/major/20190321Jean-PaulPelteret +++ /dev/null @@ -1,9 +0,0 @@ -New: A new class Differentiation::AD::VectorFunction has been -added to help implement point-wise vector functions using automatic -differentiation. In particular, this class is designed to compute the -Jacobian of a vector function that is parameterized in -terms of scalar, vector, and tensor arguments. One example of its use -would be to compute the linearization of a multi-field constitutive -law that is expressed in terms of some kinetic variables. -
-(Jean-Paul Pelteret, 2019/03/21) diff --git a/doc/news/changes/major/20190329Jean-PaulPelteret b/doc/news/changes/major/20190329Jean-PaulPelteret deleted file mode 100644 index 50d4c4b640..0000000000 --- a/doc/news/changes/major/20190329Jean-PaulPelteret +++ /dev/null @@ -1,16 +0,0 @@ -New: A new class Differentiation::SD::Expression has been added which allows -the creation and manipulation of scalar symbolic functions using the SymEngine -library. It will later be used as the basis of symbolic tensor calculus, amongst -other things. It incorporates numerous features, which currently include: -
    -
  • expression parsing,
  • -
  • comparison operations,
  • -
  • logical operations,
  • -
  • basic math operations,
  • -
  • conditional expression construction,
  • -
  • differentiation,
  • -
  • substitution (partial and complete), and
  • -
  • serialization.
  • -
-
-(Jean-Paul Pelteret, 2019/03/29) diff --git a/doc/news/changes/major/20190410LucaHeltai b/doc/news/changes/major/20190410LucaHeltai deleted file mode 100644 index 60368ce78e..0000000000 --- a/doc/news/changes/major/20190410LucaHeltai +++ /dev/null @@ -1,4 +0,0 @@ -New: The ParsedConvergenceTable class allows convenient construction of convergence tables, exploiting -parameter files. -
-(Luca Heltai, 2019/04/10) diff --git a/doc/news/changes/major/20190425RolandRichter b/doc/news/changes/major/20190425RolandRichter deleted file mode 100644 index 4cc8d2e355..0000000000 --- a/doc/news/changes/major/20190425RolandRichter +++ /dev/null @@ -1,5 +0,0 @@ -New: The tutorial examples now all use a quadrature formula with a degree depending on the degree of the -finite element, so that one changing the finite element degree does not also require changing by hand the number -of quadrature points. -
-(Roland Richter, 2019/04/25) diff --git a/doc/news/changes/major/20190501DanielGarcia-Sanchez b/doc/news/changes/major/20190501DanielGarcia-Sanchez deleted file mode 100644 index b86114206e..0000000000 --- a/doc/news/changes/major/20190501DanielGarcia-Sanchez +++ /dev/null @@ -1,6 +0,0 @@ -New: The new tutorial program step-62 shows how to calculate the resonance -frequency and the bandgap of a phononic crystal. The program solves the elastic -wave equation with Perfectly Matches Layers in the frequency domain using -complex algebra and parallelization via MUMPS and MPI. -
-(Daniel Garcia-Sanchez, 2019/05/01) diff --git a/doc/news/changes/major/20190502Wang b/doc/news/changes/major/20190502Wang deleted file mode 100644 index eb996123f5..0000000000 --- a/doc/news/changes/major/20190502Wang +++ /dev/null @@ -1,3 +0,0 @@ -New: The new tutorial program step-61 shows how to use "weak Galerkin" finite element method to solve the Poisson equation. -
-(Zhuoran Wang, 2019/05/02) diff --git a/doc/news/changes/major/20190510ArndtTurcksin b/doc/news/changes/major/20190510ArndtTurcksin deleted file mode 100644 index 952df32379..0000000000 --- a/doc/news/changes/major/20190510ArndtTurcksin +++ /dev/null @@ -1,5 +0,0 @@ -New: Ths step-64 tutorial demonstrates how to use the CUDAWrappers::MatrixFree -framework (possibly with MPI) and discusses the peculiarities of using CUDA -inside deal.II in general. -
-(Daniel Arndt, Bruno Turcksin, 2019/05/10) diff --git a/doc/news/changes/major/20190510DavidWells b/doc/news/changes/major/20190510DavidWells deleted file mode 100644 index 5c746df2ba..0000000000 --- a/doc/news/changes/major/20190510DavidWells +++ /dev/null @@ -1,4 +0,0 @@ -Deprecated: deal.II's nanoflann bindings (i.e., the KDTree class) have been -deprecated in favor of using boost::geometry::index::rtree. -
-(David Wells, 2019/05/10) diff --git a/doc/news/changes/major/20190513Many b/doc/news/changes/major/20190513Many deleted file mode 100644 index 99b5a45d68..0000000000 --- a/doc/news/changes/major/20190513Many +++ /dev/null @@ -1,4 +0,0 @@ -Improved: All tutorial programs have been reviewed and updated with new features -in the library and C++11. -
-(Daniel Arndt, David Wells, Matthias Maier, Denis Davydov, Wolfgang Bangerth, Jean-Paul Pelteret, 2019/05/13) diff --git a/doc/news/changes/minor/20171118Jean-PaulPelteret b/doc/news/changes/minor/20171118Jean-PaulPelteret deleted file mode 100644 index 49bc0b2ad9..0000000000 --- a/doc/news/changes/minor/20171118Jean-PaulPelteret +++ /dev/null @@ -1,5 +0,0 @@ -New: Classes that act as an interface to the drivers of internally supported automatic -differentiation libraries (ADOL-C and Sacado) have been implemented. A brief summary -of what these classes are used for is given in the @ref auto_symb_diff module. -
-(Jean-Paul Pelteret, 2017/11/18) diff --git a/doc/news/changes/minor/20180518DanielArndtMartinKronbichler b/doc/news/changes/minor/20180518DanielArndtMartinKronbichler deleted file mode 100644 index f45a5dfb6f..0000000000 --- a/doc/news/changes/minor/20180518DanielArndtMartinKronbichler +++ /dev/null @@ -1,5 +0,0 @@ -Fixed: Two invalid off-by-one data accesses in the initialization of -MatrixFree with face data enabled, that appeared in some rare cases on certain -configurations of processors, have been fixed. -
-(Daniel Arndt, Martin Kronbichler, 2018/05/18) diff --git a/doc/news/changes/minor/20180519DanielArndt b/doc/news/changes/minor/20180519DanielArndt deleted file mode 100644 index 64717447d9..0000000000 --- a/doc/news/changes/minor/20180519DanielArndt +++ /dev/null @@ -1,5 +0,0 @@ -Fixed: DoFTools::make_flux_sparsity_pattern was accessing invalid dof indices -in case neighboring cells were not using FiniteElement objects with the same -number of degrees of freedom. This is fixed now. -
-(Daniel Arndt, 2018/05/19) diff --git a/doc/news/changes/minor/20180521AlexanderKnieps b/doc/news/changes/minor/20180521AlexanderKnieps deleted file mode 100644 index be296b5de4..0000000000 --- a/doc/news/changes/minor/20180521AlexanderKnieps +++ /dev/null @@ -1,5 +0,0 @@ -Improved: MGTransferPrebuilt now supports -PETScWrappers::MPI::Vector and -PETScWrappers::MPI::SparseMatrix. -
-(Alexander Knieps, 2018/05/21) diff --git a/doc/news/changes/minor/20180521CeQin b/doc/news/changes/minor/20180521CeQin deleted file mode 100644 index 58f3e043e9..0000000000 --- a/doc/news/changes/minor/20180521CeQin +++ /dev/null @@ -1,3 +0,0 @@ -Fixed: Step-16 was broken caused by uninitialized variables, it is now fixed. -
-(Ce Qin, 2018/05/21) diff --git a/doc/news/changes/minor/20180524MartinKronbichlerDenisDavydov b/doc/news/changes/minor/20180524MartinKronbichlerDenisDavydov deleted file mode 100644 index 23b1c06674..0000000000 --- a/doc/news/changes/minor/20180524MartinKronbichlerDenisDavydov +++ /dev/null @@ -1,8 +0,0 @@ -Improved: MatrixFree::cell_loop() and MatrixFree::loop() directly use -LinearAlgebra::distributed::BlockVector::update_ghost_values() and -LinearAlgebra::distributed::BlockVector::compress() calls on block vectors -with many blocks, rather than splitting each method into two parts for -overlapping communication and computation. The latter is inefficient as soon -as too many MPI requests are in flight. -
-(Martin Kronbichler, Denis Davydov, 2018/05/24) diff --git a/doc/news/changes/minor/20180528MartinKronbichlerNiklasFehn b/doc/news/changes/minor/20180528MartinKronbichlerNiklasFehn deleted file mode 100644 index 9836a59403..0000000000 --- a/doc/news/changes/minor/20180528MartinKronbichlerNiklasFehn +++ /dev/null @@ -1,5 +0,0 @@ -New: The function GridTools::find_all_active_cells_around_point() returns a -list of all cells around a point, rather than only a single one for the old -GridTools::find_active_cell_around_point. -
-(Martin Kronbichler, Niklas Fehn, 2018/05/28) diff --git a/doc/news/changes/minor/20180529DenisDavydov b/doc/news/changes/minor/20180529DenisDavydov deleted file mode 100644 index 942cac916f..0000000000 --- a/doc/news/changes/minor/20180529DenisDavydov +++ /dev/null @@ -1,3 +0,0 @@ -Improved: TimerOutput now dynamically adjust to the the width of Section column. -
-(Denis Davydov, 2018/05/29) diff --git a/doc/news/changes/minor/20180529DenisDavydov_b b/doc/news/changes/minor/20180529DenisDavydov_b deleted file mode 100644 index 231c323f13..0000000000 --- a/doc/news/changes/minor/20180529DenisDavydov_b +++ /dev/null @@ -1,4 +0,0 @@ -New: TimerOutput::cpu_and_wall_times_grouped will print CPU and -wallclock time in a single table. -
-(Denis Davydov, 2018/05/29) diff --git a/doc/news/changes/minor/20180606SambitDas b/doc/news/changes/minor/20180606SambitDas deleted file mode 100644 index cc39f0cf67..0000000000 --- a/doc/news/changes/minor/20180606SambitDas +++ /dev/null @@ -1,3 +0,0 @@ -Improved: Extend ScaLAPACKMatrix::invert() to use pXtrtri for inversion of triangular matrices. -
-(Sambit Das, 2018/06/06) diff --git a/doc/news/changes/minor/20180610DanielArndt b/doc/news/changes/minor/20180610DanielArndt deleted file mode 100644 index 9b1a77ac63..0000000000 --- a/doc/news/changes/minor/20180610DanielArndt +++ /dev/null @@ -1,5 +0,0 @@ -Fixed: BlockLinearOperator::vmult(), BlockLinearOperator::vmult_add(), -BlockLinearOperator::Tvmult() and BlockLinearOperator::Tvmult_add() -can be used with identical source and destination vectors. -
-(Daniel Arndt, 2018/06/10) diff --git a/doc/news/changes/minor/20180611DanielArndt b/doc/news/changes/minor/20180611DanielArndt deleted file mode 100644 index 91a37d343f..0000000000 --- a/doc/news/changes/minor/20180611DanielArndt +++ /dev/null @@ -1,4 +0,0 @@ -Deprecated: FunctionMap is deprecated. It is recommended to -use the aliased type directly. -
-(Daniel Arndt, 2018/06/11) diff --git a/doc/news/changes/minor/20180611MatthiasMaier b/doc/news/changes/minor/20180611MatthiasMaier deleted file mode 100644 index 1e0bf2ca23..0000000000 --- a/doc/news/changes/minor/20180611MatthiasMaier +++ /dev/null @@ -1,4 +0,0 @@ -Fixed: CMake now supports again in-source builds (This functionality was -accidentally broken in the previous release). -
-(Matthias Maier, 2018/06/11) diff --git a/doc/news/changes/minor/20180612DenisDavydov b/doc/news/changes/minor/20180612DenisDavydov deleted file mode 100644 index cf260cba94..0000000000 --- a/doc/news/changes/minor/20180612DenisDavydov +++ /dev/null @@ -1,5 +0,0 @@ -Bugfix: Fixed a bug where VectorDataExchange::ghosts_were_set was -not set inside MatrixFree::cell_loop() for block vectors -with many blocks. -
-(Denis Davydov, 2018/06/12) diff --git a/doc/news/changes/minor/20180614PiYuehChuang b/doc/news/changes/minor/20180614PiYuehChuang deleted file mode 100644 index 44bda16aa1..0000000000 --- a/doc/news/changes/minor/20180614PiYuehChuang +++ /dev/null @@ -1,4 +0,0 @@ -Fixed: Mismatched numbers of components between the exact solution and -underlying FE in Step-51. -
-(Pi-Yueh Chuang, 2018/06/14) diff --git a/doc/news/changes/minor/20180614UweKoecher b/doc/news/changes/minor/20180614UweKoecher deleted file mode 100644 index e12782b921..0000000000 --- a/doc/news/changes/minor/20180614UweKoecher +++ /dev/null @@ -1,5 +0,0 @@ -Bugfix: Fixed bugs for TrilinosWrapper::SparseMatrix::add(factor, other_matrix) -and TrilinosWrapper::SparseMatrix::copy_from(other_matrix) for the case of -non-contiguous rows. -
-(Uwe Koecher, 2018/06/14) diff --git a/doc/news/changes/minor/20180615DanielArndt b/doc/news/changes/minor/20180615DanielArndt deleted file mode 100644 index 1185c39a79..0000000000 --- a/doc/news/changes/minor/20180615DanielArndt +++ /dev/null @@ -1,4 +0,0 @@ -Fixed: The eigenvalue approximation in SolverGMRES failed if no iterations -were performed. Now, there is simply no output in this case. -
-(Daniel Arndt, 2018/06/15) diff --git a/doc/news/changes/minor/20180616JohsuaHanophy b/doc/news/changes/minor/20180616JohsuaHanophy deleted file mode 100644 index 91bb61a11e..0000000000 --- a/doc/news/changes/minor/20180616JohsuaHanophy +++ /dev/null @@ -1,6 +0,0 @@ -Fixed: TrilinosWrappers::MPI::Vector::reinit check now checks if -parallel_partitioner is_ascending_and_one_to_one before calling -make_trilinos_map because make_trilinos_map may be able to make -a linear map if is_ascending_and_one_to_one is true. -
-(Joshua Hanophy, 2018/06/16) diff --git a/doc/news/changes/minor/20180618SvenjaSchoeder b/doc/news/changes/minor/20180618SvenjaSchoeder deleted file mode 100644 index 7c5f98b574..0000000000 --- a/doc/news/changes/minor/20180618SvenjaSchoeder +++ /dev/null @@ -1,6 +0,0 @@ -New: The LinearAlgebra::distributed::Vector::compress() function has -gained two new combine operations VectorOperation::min and -VectorOperation::max to define the entry at the owning processor as -the minimum/maximum of its own value and the one coming from a ghost. -
-(Svenja Schoeder, 2018/06/18) diff --git a/doc/news/changes/minor/20180618WolfgangBangerth b/doc/news/changes/minor/20180618WolfgangBangerth deleted file mode 100644 index b7b5d808c8..0000000000 --- a/doc/news/changes/minor/20180618WolfgangBangerth +++ /dev/null @@ -1,9 +0,0 @@ -Changed: Calling GridGenerator::refine_and_coarsen_fixed_fraction() -and GridGenerator::refine_and_coarsen_fixed_fraction() with values for -the coarsen and refine fractions that added to 1.0 in exact -arithmetic, but something slightly larger in floating point -arithmetic, resulted in an error. These functions are now slightly -more relaxed in that they allow arguments that add to 1.0 up to a -small floating point round off error. -
-(Wolfgang Bangerth, 2018/06/18) diff --git a/doc/news/changes/minor/20180620DanielArndt b/doc/news/changes/minor/20180620DanielArndt deleted file mode 100644 index ce9a92c37a..0000000000 --- a/doc/news/changes/minor/20180620DanielArndt +++ /dev/null @@ -1,4 +0,0 @@ -Fixed: FETools::back_interpolate can be used -for TrilinosWrappers::MPI::BlockVector. -
-(Daniel Arndt, 2018/06/20) diff --git a/doc/news/changes/minor/20180621DenisDavydov b/doc/news/changes/minor/20180621DenisDavydov deleted file mode 100644 index 28e18a78c0..0000000000 --- a/doc/news/changes/minor/20180621DenisDavydov +++ /dev/null @@ -1,5 +0,0 @@ -New: Extend get_vector_data_ranges() to return extra element in -the tuple to represent DataComponentInterpretation. The functions -were renamed to get_nonscalar_data_ranges(). -
-(Denis Davydov, 2018/06/21) diff --git a/doc/news/changes/minor/20180621DenisDavydov_b b/doc/news/changes/minor/20180621DenisDavydov_b deleted file mode 100644 index 8b52b7dc69..0000000000 --- a/doc/news/changes/minor/20180621DenisDavydov_b +++ /dev/null @@ -1,4 +0,0 @@ -New: Add support for output of tensor-valued data in -DataOut::write_vtu(). -
-(Denis Davydov, 2018/06/21) diff --git a/doc/news/changes/minor/20180704MartinKronbichler b/doc/news/changes/minor/20180704MartinKronbichler deleted file mode 100644 index 6ef9647552..0000000000 --- a/doc/news/changes/minor/20180704MartinKronbichler +++ /dev/null @@ -1,4 +0,0 @@ -New: The class MatrixFreeFunctions::CellwiseInverseMassMatrix can now also be -used in 1D. -
-(Martin Kronbichler, 2018/07/04) diff --git a/doc/news/changes/minor/20180704MartinKronbichler-1 b/doc/news/changes/minor/20180704MartinKronbichler-1 deleted file mode 100644 index 1c487cbea4..0000000000 --- a/doc/news/changes/minor/20180704MartinKronbichler-1 +++ /dev/null @@ -1,5 +0,0 @@ -Fixed: The functions FEFaceEvaluation::evaluate and -FEFaceEvaluation::integrate would access invalid memory when only evaluating -function values and using multiple components in 1D. This is now fixed. -
-(Martin Kronbichler, 2018/07/04) diff --git a/doc/news/changes/minor/20180706DenisDavydov b/doc/news/changes/minor/20180706DenisDavydov deleted file mode 100644 index 2a80d652b0..0000000000 --- a/doc/news/changes/minor/20180706DenisDavydov +++ /dev/null @@ -1,4 +0,0 @@ -New: Add GridGenerator::plate_with_a_hole() that generates a -rectangular plate with an (offset) cylindrical hole. -
-(Denis Davydov, 2018/06/21) diff --git a/doc/news/changes/minor/20180708DanielArndt b/doc/news/changes/minor/20180708DanielArndt deleted file mode 100644 index fcad1d8ce4..0000000000 --- a/doc/news/changes/minor/20180708DanielArndt +++ /dev/null @@ -1,3 +0,0 @@ -New: GridGenerator::merge_triangulations gained an option to copy manifold ids. -
-(Daniel Arndt, 2018/07/08) diff --git a/doc/news/changes/minor/20180710DanielArndt b/doc/news/changes/minor/20180710DanielArndt deleted file mode 100644 index 4fb45882cc..0000000000 --- a/doc/news/changes/minor/20180710DanielArndt +++ /dev/null @@ -1,4 +0,0 @@ -Fixed: GridTools::delete_duplicated_vertices also treats the SubCellData -object correctly when renumbering the vertices. -
-(Daniel Arndt, 2018/07/08) diff --git a/doc/news/changes/minor/20180711MathiasAnselmannDanielArndt b/doc/news/changes/minor/20180711MathiasAnselmannDanielArndt deleted file mode 100644 index 8b9c6afb44..0000000000 --- a/doc/news/changes/minor/20180711MathiasAnselmannDanielArndt +++ /dev/null @@ -1,6 +0,0 @@ -Fixed: Iterating over the entries of a TrilinosWrappers::SparsityPattern object -in parallel and after calling TrilinosWrappers::SparsityPattern::compress() -works now. -
-(Mathias Anselmann, Daniel Arndt, 2018/07/11) - diff --git a/doc/news/changes/minor/20180715DavidWells b/doc/news/changes/minor/20180715DavidWells deleted file mode 100644 index b589f5e14b..0000000000 --- a/doc/news/changes/minor/20180715DavidWells +++ /dev/null @@ -1,5 +0,0 @@ -New: A new function GridGenerator::concentric_hyper_shells has been added. This -function generates a grid comprised of shells of varying widths, where the -shells near the center are much thinner than those near the outer boundary. -
-(David Wells, 2018/07/15) diff --git a/doc/news/changes/minor/20180715Jean-PaulPelteret b/doc/news/changes/minor/20180715Jean-PaulPelteret deleted file mode 100644 index 221a5b0f70..0000000000 --- a/doc/news/changes/minor/20180715Jean-PaulPelteret +++ /dev/null @@ -1,6 +0,0 @@ -Changed: The Subscriptor class has been made thread-safe, and its behavior in -debug and release modes are now identical. Although this makes subscription and -un-subscription slightly more expensive in release mode, debugging should be -easier overall. -
-(Jean-Paul Pelteret, 2018/07/15) diff --git a/doc/news/changes/minor/20180720MarcFehling b/doc/news/changes/minor/20180720MarcFehling deleted file mode 100644 index aac80a269b..0000000000 --- a/doc/news/changes/minor/20180720MarcFehling +++ /dev/null @@ -1,5 +0,0 @@ -Fixed: hp::DoFHandler::distribute_dofs() now works on -parallel::distributed::Triangulation<3> objects that -contain artificial cells. -
-(Marc Fehling, 2018/07/20) diff --git a/doc/news/changes/minor/20180721LucaHeltai b/doc/news/changes/minor/20180721LucaHeltai deleted file mode 100644 index fc1b6b01cb..0000000000 --- a/doc/news/changes/minor/20180721LucaHeltai +++ /dev/null @@ -1,4 +0,0 @@ -New: Add new constructor type for FunctionParser class. -
-(Luca Heltai, 2018/07/21) - diff --git a/doc/news/changes/minor/20180722LucaHeltaiBrunoTurcksin b/doc/news/changes/minor/20180722LucaHeltaiBrunoTurcksin deleted file mode 100644 index e717bb158e..0000000000 --- a/doc/news/changes/minor/20180722LucaHeltaiBrunoTurcksin +++ /dev/null @@ -1,4 +0,0 @@ -New: Added geometry adaptors for boost. -
-(Luca Heltai, Bruno Turcksin, 2018/07/22) - diff --git a/doc/news/changes/minor/20180724LucaHeltai b/doc/news/changes/minor/20180724LucaHeltai deleted file mode 100644 index 17602a60aa..0000000000 --- a/doc/news/changes/minor/20180724LucaHeltai +++ /dev/null @@ -1,4 +0,0 @@ -New: Add boost adaptor for dealii::BoundingBox. -
-(Luca Heltai, 2018/07/24) - diff --git a/doc/news/changes/minor/20180726AlexanderGrayver b/doc/news/changes/minor/20180726AlexanderGrayver deleted file mode 100644 index a3aeb9d3ca..0000000000 --- a/doc/news/changes/minor/20180726AlexanderGrayver +++ /dev/null @@ -1,5 +0,0 @@ -Deprecate project_boundary_values_curl_conforming in favor -of project_boundary_values_curl_conforming_l2. The former -has a number of known limitations and bugs. -
-(Alexander Grayver, 2018/07/26) diff --git a/doc/news/changes/minor/20180726DenisDavydov b/doc/news/changes/minor/20180726DenisDavydov deleted file mode 100644 index f19d6b7d91..0000000000 --- a/doc/news/changes/minor/20180726DenisDavydov +++ /dev/null @@ -1,3 +0,0 @@ -New: Add FiniteSizeHistory class to store a finite-size history of objects. -
-(Denis Davydov, 2018/07/26) diff --git a/doc/news/changes/minor/20180727AlexanderGrayver b/doc/news/changes/minor/20180727AlexanderGrayver deleted file mode 100644 index 41e5f75e84..0000000000 --- a/doc/news/changes/minor/20180727AlexanderGrayver +++ /dev/null @@ -1,4 +0,0 @@ -Added support for high-order VTK output by using newly -introduced Lagrange VTK cells. -
-(Alexander Grayver, 2018/07/27) diff --git a/doc/news/changes/minor/20180801AlexanderGrayver b/doc/news/changes/minor/20180801AlexanderGrayver deleted file mode 100644 index da7ae494b4..0000000000 --- a/doc/news/changes/minor/20180801AlexanderGrayver +++ /dev/null @@ -1,4 +0,0 @@ -Added support for high-order VTU output by using newly -introduced Lagrange VTK cells. -
-(Alexander Grayver, 2018/08/01) diff --git a/doc/news/changes/minor/20180801BrunoTurcksin b/doc/news/changes/minor/20180801BrunoTurcksin deleted file mode 100644 index 6ea95a5706..0000000000 --- a/doc/news/changes/minor/20180801BrunoTurcksin +++ /dev/null @@ -1,6 +0,0 @@ -New: LinearAlgebra::distributed::Vector has an extra template parameter -MemorySpace. This new template parameter can be used if the data should be -allocated on the host or on the device. -
-(Bruno Turcksin, 2018/08/01) - diff --git a/doc/news/changes/minor/20180801DanielArndt b/doc/news/changes/minor/20180801DanielArndt deleted file mode 100644 index f29df0e876..0000000000 --- a/doc/news/changes/minor/20180801DanielArndt +++ /dev/null @@ -1,4 +0,0 @@ -New: GridGenerator::merge_triangulations can merge multiple -Triangulation objects at once. -
-(Daniel Arndt, 2018/08/01) diff --git a/doc/news/changes/minor/20180802BrunoTurcksin b/doc/news/changes/minor/20180802BrunoTurcksin deleted file mode 100644 index 9b894a0aaa..0000000000 --- a/doc/news/changes/minor/20180802BrunoTurcksin +++ /dev/null @@ -1,5 +0,0 @@ -Fixed: The import function for LinearAlgebra::distributed::Vector would fail if -the IndexSet of the ReadWriteVector has no locally owned element -
-(Bruno Turcksin, 2018/08/02) - diff --git a/doc/news/changes/minor/20180802DenisDavydov b/doc/news/changes/minor/20180802DenisDavydov deleted file mode 100644 index c3b00e3a83..0000000000 --- a/doc/news/changes/minor/20180802DenisDavydov +++ /dev/null @@ -1,4 +0,0 @@ -Fixed: Minor issues when using matrix-free cell categorization -with multi-grid operators. -
-(Denis Davydov, 2018/08/02) diff --git a/doc/news/changes/minor/20180805DavidWells b/doc/news/changes/minor/20180805DavidWells deleted file mode 100644 index 9d133e018b..0000000000 --- a/doc/news/changes/minor/20180805DavidWells +++ /dev/null @@ -1,4 +0,0 @@ -New: A convenience function Triangulation::active_face_iterators() (which is like -Triangulation::active_cell_iterators(), but for faces) has been added. -
-(David Wells, 2018/08/05) diff --git a/doc/news/changes/minor/20180806BrunoTurcksin b/doc/news/changes/minor/20180806BrunoTurcksin deleted file mode 100644 index dcf010d4be..0000000000 --- a/doc/news/changes/minor/20180806BrunoTurcksin +++ /dev/null @@ -1,4 +0,0 @@ -New: Add support for constraint when using matrix-free on GPU. Note you cannot -set constraints in 2D if the degree of the finite element is even. -
-(Bruno Turcksin, 2018/08/06) diff --git a/doc/news/changes/minor/20180806MartinKronbichler b/doc/news/changes/minor/20180806MartinKronbichler deleted file mode 100644 index 981519b29c..0000000000 --- a/doc/news/changes/minor/20180806MartinKronbichler +++ /dev/null @@ -1,5 +0,0 @@ -Improved: FEEvaluation and FEFaceEvaluation have gained support for -renumbering of degrees of freedom for fully discontinuous finite element -spaces which can improve performance by around 10 percent. -
-(Martin Kronbichler, 2018/08/06) diff --git a/doc/news/changes/minor/20180806MartinKronbichler-1 b/doc/news/changes/minor/20180806MartinKronbichler-1 deleted file mode 100644 index 9fa96ca6c7..0000000000 --- a/doc/news/changes/minor/20180806MartinKronbichler-1 +++ /dev/null @@ -1,6 +0,0 @@ -New: The new function -MatrixFreeOperators::CellwiseInverseMassMatrix::transform_from_q_points_to_basis() -enables to change the basis from a representation in quadrature points into -the original basis of FEEvaluation. -
-(Martin Kronbichler, 2018/08/06) diff --git a/doc/news/changes/minor/20180809StefanKaessmairDanielArndt b/doc/news/changes/minor/20180809StefanKaessmairDanielArndt deleted file mode 100644 index 4588a98db9..0000000000 --- a/doc/news/changes/minor/20180809StefanKaessmairDanielArndt +++ /dev/null @@ -1,4 +0,0 @@ -Improved: Triangulation::prepare_coarsening_and_refinement also takes care of -limiting the level difference across periodic boundary faces. -
-(Daniel Arndt, Stefan Kaessmair, 2018/08/09) diff --git a/doc/news/changes/minor/20180810BenjaminBrands b/doc/news/changes/minor/20180810BenjaminBrands deleted file mode 100644 index 44d7d40ce9..0000000000 --- a/doc/news/changes/minor/20180810BenjaminBrands +++ /dev/null @@ -1,3 +0,0 @@ -Fixed: Bug using ScaLAPACKMatrix::save() and load() for configurations with pHDF5 in combination with serial HDF5 matrices from user code. -
-(Benjamin Brands, 2018/08/10) diff --git a/doc/news/changes/minor/20180813AlexanderKnieps b/doc/news/changes/minor/20180813AlexanderKnieps deleted file mode 100644 index aada74e481..0000000000 --- a/doc/news/changes/minor/20180813AlexanderKnieps +++ /dev/null @@ -1,3 +0,0 @@ -Fixed: MGConstrainedDofs::initialize(...) now handles refinement edges across periodic boundaries correctly. -
-(Alexander Knieps, 2018/08/13) diff --git a/doc/news/changes/minor/20180816DanielArndt b/doc/news/changes/minor/20180816DanielArndt deleted file mode 100644 index 040f6704e8..0000000000 --- a/doc/news/changes/minor/20180816DanielArndt +++ /dev/null @@ -1,4 +0,0 @@ -Fixed: CUDAWrappers::Vector performs now a deep copy instead of a shallow copy -in its copy assignment operator. -
-(Daniel Arndt, 2018/08/16) diff --git a/doc/news/changes/minor/20180817DanielArndt b/doc/news/changes/minor/20180817DanielArndt deleted file mode 100644 index 6583785125..0000000000 --- a/doc/news/changes/minor/20180817DanielArndt +++ /dev/null @@ -1,5 +0,0 @@ -New: There is LinearAlgebra::CUDAWrappers::Vector::norm_sqr() for computing -the squared l2-norm and LinearAlgebra::CUDAWrappers::Vector::swap() -for swapping two vectors. -
-(Daniel Arndt, 2018/08/17) diff --git a/doc/news/changes/minor/20180817DanielArndt-1 b/doc/news/changes/minor/20180817DanielArndt-1 deleted file mode 100644 index 3f00cc1e4b..0000000000 --- a/doc/news/changes/minor/20180817DanielArndt-1 +++ /dev/null @@ -1,4 +0,0 @@ -Fixed: Throwing an exception in Assert doesn't slice objects derived from -ExceptionBase anymore. -
-(Daniel Arndt, 2018/08/17) diff --git a/doc/news/changes/minor/20180820DanielArndt b/doc/news/changes/minor/20180820DanielArndt deleted file mode 100644 index bc1b6fafe6..0000000000 --- a/doc/news/changes/minor/20180820DanielArndt +++ /dev/null @@ -1,5 +0,0 @@ -New: There are new methods CUDAWrappers::SparseMatrix::print() and -CUDAWrappers::SparseMatrix::print_formatted(). Additionally, -CUDAWrappers::SparseMatrix gained a move assignment operator. -
-(Daniel Arndt, 2018/08/20) diff --git a/doc/news/changes/minor/20180820DanielArndt-1 b/doc/news/changes/minor/20180820DanielArndt-1 deleted file mode 100644 index 99f07fdbfc..0000000000 --- a/doc/news/changes/minor/20180820DanielArndt-1 +++ /dev/null @@ -1,4 +0,0 @@ -New: There are nothrow versions of AssertCUDA and AssertCusparse, namely -AssertNothrowCUDA and AssertNothrowCusparse. -
-(Daniel Arndt, 2018/08/20) diff --git a/doc/news/changes/minor/20180820DanielArndt-2 b/doc/news/changes/minor/20180820DanielArndt-2 deleted file mode 100644 index db679bce49..0000000000 --- a/doc/news/changes/minor/20180820DanielArndt-2 +++ /dev/null @@ -1,4 +0,0 @@ -New: CUDAWrappers::PreconditionILU and CUDAWrappers::PreconditionIC can be used -for preconditioning CUDAWrappers::SparseMatrix objects. -
-(Daniel Arndt, 2018/08/20) diff --git a/doc/news/changes/minor/20180820DavidWells b/doc/news/changes/minor/20180820DavidWells deleted file mode 100644 index 73b873eb93..0000000000 --- a/doc/news/changes/minor/20180820DavidWells +++ /dev/null @@ -1,4 +0,0 @@ -New: Table and FullMatrix now have complete (both mutable and const) -random-access iterators. -
-(David Wells, 2018/08/20) diff --git a/doc/news/changes/minor/20180821SvenjaSchoeder b/doc/news/changes/minor/20180821SvenjaSchoeder deleted file mode 100644 index 1e91757b2e..0000000000 --- a/doc/news/changes/minor/20180821SvenjaSchoeder +++ /dev/null @@ -1,6 +0,0 @@ -New: Add a mask argument to filter out some vector lanes in FEEvaluationBase -This is required for local time stepping using the MatrixFree framework, -because some cells of batches must be excluded from read/write operations -when operating on different time steps compared to their neighbor cells. -
-(Svenja Schoeder, 2018/08/21) diff --git a/doc/news/changes/minor/20180821WolfgangBangerth b/doc/news/changes/minor/20180821WolfgangBangerth deleted file mode 100644 index 813cd5a401..0000000000 --- a/doc/news/changes/minor/20180821WolfgangBangerth +++ /dev/null @@ -1,4 +0,0 @@ -Fixed: The function Particles::ParticleAccessor::serialize() was -declared but not implemented. This is now fixed. -
-(Wolfgang Bangerth, 2018/08/21) diff --git a/doc/news/changes/minor/20180822BrunoTurcksin b/doc/news/changes/minor/20180822BrunoTurcksin deleted file mode 100644 index 58b23bb0e1..0000000000 --- a/doc/news/changes/minor/20180822BrunoTurcksin +++ /dev/null @@ -1,4 +0,0 @@ -Fixed: TrilinosWrappers::SparseMatrix::mmult() sometimes gave the wrong result -in parallel. -
-(Damien Lebrun-Grandie and Bruno Turcksin, 2018/08/22) diff --git a/doc/news/changes/minor/20180824DustinKumor b/doc/news/changes/minor/20180824DustinKumor deleted file mode 100644 index be18a30a8b..0000000000 --- a/doc/news/changes/minor/20180824DustinKumor +++ /dev/null @@ -1,4 +0,0 @@ -Fixed: Member function AffineConstraints::add_entries() now skips already -existing entries. -
-(Dustin Kumor, 2018/08/24) diff --git a/doc/news/changes/minor/20180901DanielArndt b/doc/news/changes/minor/20180901DanielArndt deleted file mode 100644 index ba5b54f5fd..0000000000 --- a/doc/news/changes/minor/20180901DanielArndt +++ /dev/null @@ -1,5 +0,0 @@ -New: Utilities::CUDA::allocate_device_data() and -Utilities::CUDA::delete_device_data() help to manage data on CUDA devices -using std::unique_ptr. -
-(Daniel Arndt, 2018/09/01) diff --git a/doc/news/changes/minor/20180904EldarKhattatov b/doc/news/changes/minor/20180904EldarKhattatov deleted file mode 100644 index 0434ff1d61..0000000000 --- a/doc/news/changes/minor/20180904EldarKhattatov +++ /dev/null @@ -1,6 +0,0 @@ -Added: New function -Utilities::MPI::compute_n_point_to_point_communications() -is implemented to be used for computing number of processes -in an MPI universe to expect communication from. -
-(Eldar Khattatov, 2018/09/04) diff --git a/doc/news/changes/minor/20180906Bangerth b/doc/news/changes/minor/20180906Bangerth deleted file mode 100644 index 88f492230e..0000000000 --- a/doc/news/changes/minor/20180906Bangerth +++ /dev/null @@ -1,5 +0,0 @@ -New: The function DoFRenumbering::hierarchical() is now also available -for hp::DoFHandler objects, as well as for DoFHandlers build on -triangulations with `dim != spacedim`. -
-(Wolfgang Bangerth, 2018/09/06) diff --git a/doc/news/changes/minor/20180913DanielArndt b/doc/news/changes/minor/20180913DanielArndt deleted file mode 100644 index 0a37e40c6d..0000000000 --- a/doc/news/changes/minor/20180913DanielArndt +++ /dev/null @@ -1,4 +0,0 @@ -Fixed: VectorTools::project_boundary_values_div_conforming works correctly -in case the DoFHandler object contains more than one FE_RaviartThomas element. -
-(Daniel Arndt, 2018/09/13) diff --git a/doc/news/changes/minor/20180913DavidWells b/doc/news/changes/minor/20180913DavidWells deleted file mode 100644 index 882500f487..0000000000 --- a/doc/news/changes/minor/20180913DavidWells +++ /dev/null @@ -1,8 +0,0 @@ -Fixed: make test now runs in parallel automatically (i.e., it uses -a CMake command to determine the number of cores available). Since make -test just immediately invokes ctest as a subprocess, it is -currently not possible to link the number of globally available -make processes with the number of concurrently run tests; i.e., -the number of cores make test uses is not changeable by users. -
-(David Wells, 2018/09/13) diff --git a/doc/news/changes/minor/20180913DenisDavydov b/doc/news/changes/minor/20180913DenisDavydov deleted file mode 100644 index 3d6b6b3d4e..0000000000 --- a/doc/news/changes/minor/20180913DenisDavydov +++ /dev/null @@ -1,3 +0,0 @@ -New: Add line minimization functions. -
-(Denis Davydov, 2018/09/13) diff --git a/doc/news/changes/minor/20180916Heister b/doc/news/changes/minor/20180916Heister deleted file mode 100644 index aeb1d3aa5b..0000000000 --- a/doc/news/changes/minor/20180916Heister +++ /dev/null @@ -1,3 +0,0 @@ -New: added the function TrilinosWrappers::MPI::Vector::import() to get data from a ReadWriteVector. -
-(Timo Heister, 2018/09/16) diff --git a/doc/news/changes/minor/20180917DanielArndt b/doc/news/changes/minor/20180917DanielArndt deleted file mode 100644 index f61b1bf903..0000000000 --- a/doc/news/changes/minor/20180917DanielArndt +++ /dev/null @@ -1,3 +0,0 @@ -New: SolverSelector gained a new constructor initializing the object completely. -
-(Daniel Arndt, 2018/09/17) diff --git a/doc/news/changes/minor/20180919DenisDavydov b/doc/news/changes/minor/20180919DenisDavydov deleted file mode 100644 index 3588933927..0000000000 --- a/doc/news/changes/minor/20180919DenisDavydov +++ /dev/null @@ -1,4 +0,0 @@ -New: extend Patterns::Tools::Convert to work with ComponentMask -and std::unique_ptr. -
-(Denis Davydov, 2018/09/19) diff --git a/doc/news/changes/minor/20180920DenisDavydov b/doc/news/changes/minor/20180920DenisDavydov deleted file mode 100644 index a1767d7433..0000000000 --- a/doc/news/changes/minor/20180920DenisDavydov +++ /dev/null @@ -1,4 +0,0 @@ -New: Add optional flag to ParameterHandler to skip undefined -sections and parameters. -
-(Denis Davydov, 2018/09/20) diff --git a/doc/news/changes/minor/20180920MartinKronbichler b/doc/news/changes/minor/20180920MartinKronbichler deleted file mode 100644 index d5f83ebd0c..0000000000 --- a/doc/news/changes/minor/20180920MartinKronbichler +++ /dev/null @@ -1,4 +0,0 @@ -Fixed: MatrixFree::loop() would not zero a vector if all degrees of freedom -are constrained. This is now fixed. -
-(Martin Kronbichler, 2018/09/20) diff --git a/doc/news/changes/minor/20180920YuxiangWangJean-PaulPelteret b/doc/news/changes/minor/20180920YuxiangWangJean-PaulPelteret deleted file mode 100644 index e2028eeb00..0000000000 --- a/doc/news/changes/minor/20180920YuxiangWangJean-PaulPelteret +++ /dev/null @@ -1,4 +0,0 @@ -Fixed: The GridIn::read_abaqus() function now correctly reads in grids designed -for the co-dimension 1 case (specifically with dim == 2 and spacedim == 3). -
-(Yuxiang Wang, Jean-Paul Pelteret, 2018/09/20) diff --git a/doc/news/changes/minor/20180926DanielArndt b/doc/news/changes/minor/20180926DanielArndt deleted file mode 100644 index 71c5d52cff..0000000000 --- a/doc/news/changes/minor/20180926DanielArndt +++ /dev/null @@ -1,4 +0,0 @@ -New: Support for complex values can be controlled using the CMake flag -DEAL_II_WITH_COMPLEX_VALUES. -
-(Daniel Arndt, 2019/09/26) diff --git a/doc/news/changes/minor/20180927Bangerth b/doc/news/changes/minor/20180927Bangerth deleted file mode 100644 index 5a78f23fe1..0000000000 --- a/doc/news/changes/minor/20180927Bangerth +++ /dev/null @@ -1,9 +0,0 @@ -Deprecated: The Threads::Mutex class is now derived from -std::mutex. As a consequence, the Threads::Mutex::ScopedLock class is -now no longer necessary and is deprecated in favor of std::lock_guard -or any of the other similar classes provided by C++11 and -later. Similarly, the Threads::Mutex::acquire() and -Threads::Mutex::release() functions are deprecated in favor of the -corresponding functions in the std::mutex base class. -
-(Wolfgang Bangerth, 2018/09/27) diff --git a/doc/news/changes/minor/20180927Bangerth-2 b/doc/news/changes/minor/20180927Bangerth-2 deleted file mode 100644 index 061dfd91b5..0000000000 --- a/doc/news/changes/minor/20180927Bangerth-2 +++ /dev/null @@ -1,4 +0,0 @@ -Deprecated: The Threads::ConditionVariable class is now -deprecated. Use `std::condition_variable` instead. -
-(Wolfgang Bangerth, 2018/09/27) diff --git a/doc/news/changes/minor/20180927Bangerth-3 b/doc/news/changes/minor/20180927Bangerth-3 deleted file mode 100644 index 0eaa866ccd..0000000000 --- a/doc/news/changes/minor/20180927Bangerth-3 +++ /dev/null @@ -1,6 +0,0 @@ -Deprecated: The Threads::PosixThreadBarrier class and the -corresponding Threads::Barrier `using` declaration are deprecated. The -functionality implemented by these classes is easily replaced by C++11 -functionality. -
-(Wolfgang Bangerth, 2018/09/27) diff --git a/doc/news/changes/minor/20180927Bangerth-4 b/doc/news/changes/minor/20180927Bangerth-4 deleted file mode 100644 index eb34cf5acf..0000000000 --- a/doc/news/changes/minor/20180927Bangerth-4 +++ /dev/null @@ -1,9 +0,0 @@ -Removed: The Threads::DummyMutex, Threads::DummyConditionVariable, and -Threads::DummyThreadBarrier classes have been removed. These were only -used if deal.II was compiled without thread support, in which case -certain functionality from the TBB was not available. But the -implementations of the underlying functionality is now unconditionally -available via the C++11 standard library, and so we don't need the -dummy implementations any more. -
-(Wolfgang Bangerth, 2018/09/27) diff --git a/doc/news/changes/minor/20181001MarcFehling b/doc/news/changes/minor/20181001MarcFehling deleted file mode 100644 index 3431476c0c..0000000000 --- a/doc/news/changes/minor/20181001MarcFehling +++ /dev/null @@ -1,6 +0,0 @@ -New: Class parallel::distributed::CellWeights allows to set the -weight of a cell depending on the number of degrees of freedom -associated with it. This guarantees an improved load balancing -in case a hp::DoFHandler is used on a p::d::Triangulation. -
-(Marc Fehling, 2018/10/01) diff --git a/doc/news/changes/minor/20181004Bangerth b/doc/news/changes/minor/20181004Bangerth deleted file mode 100644 index 3250120129..0000000000 --- a/doc/news/changes/minor/20181004Bangerth +++ /dev/null @@ -1,5 +0,0 @@ -New: There is now a constructor of hp::QCollection that, like the -existing one of hp::FECollection, takes a variable number of -quadrature objects and creates a collection from it. -
-(Wolfgang Bangerth, 2018/10/04) diff --git a/doc/news/changes/minor/20181005Bangerth b/doc/news/changes/minor/20181005Bangerth deleted file mode 100644 index b9762690e3..0000000000 --- a/doc/news/changes/minor/20181005Bangerth +++ /dev/null @@ -1,6 +0,0 @@ -Deprecated: The Threads::n_existing_threads() and -Threads::this_thread_id() functions have been deprecated. There are -equivalent C++11 functions that provide the same kind of -functionality. -
-(Wolfgang Bangerth, 2018/10/05) diff --git a/doc/news/changes/minor/20181005DenisDavydov b/doc/news/changes/minor/20181005DenisDavydov deleted file mode 100644 index 10e6241a56..0000000000 --- a/doc/news/changes/minor/20181005DenisDavydov +++ /dev/null @@ -1,4 +0,0 @@ -New: Add inverse_Hilbert_space_filling_curve() to map points in dim-dimensional -space to line index of the Hilbert space filling curve. -
-(Denis Davydov, 2018/10/05) diff --git a/doc/news/changes/minor/20181005MartinKronbichlerBrunoTurcksinSambitDas b/doc/news/changes/minor/20181005MartinKronbichlerBrunoTurcksinSambitDas deleted file mode 100644 index 30259465e8..0000000000 --- a/doc/news/changes/minor/20181005MartinKronbichlerBrunoTurcksinSambitDas +++ /dev/null @@ -1,4 +0,0 @@ -The class VectorizedArray has gained support for the intrinsics of Altivec -of IBM Power processors. -
-(Martin Kronbichler, Bruno Turcksin, Sambit Das, 2018/10/05) diff --git a/doc/news/changes/minor/20181005TimoHeister b/doc/news/changes/minor/20181005TimoHeister deleted file mode 100644 index 004c5b061d..0000000000 --- a/doc/news/changes/minor/20181005TimoHeister +++ /dev/null @@ -1,3 +0,0 @@ -The computation of normal vectors on very small cells could fail. This is now fixed. -
-(Timo Heister, 2018/10/05) diff --git a/doc/news/changes/minor/20181006LucaHeltai b/doc/news/changes/minor/20181006LucaHeltai deleted file mode 100644 index f1426feb81..0000000000 --- a/doc/news/changes/minor/20181006LucaHeltai +++ /dev/null @@ -1,5 +0,0 @@ -New: Added RTree class and pack_rtree() function to create a boost::geometry::index::rtree from -containers and/or iterators of BoundingBox, Point, or Segment objects. -
-(Luca Heltai, 2018/10/06) - diff --git a/doc/news/changes/minor/20181008MarcFehling b/doc/news/changes/minor/20181008MarcFehling deleted file mode 100644 index 879a836e3f..0000000000 --- a/doc/news/changes/minor/20181008MarcFehling +++ /dev/null @@ -1,5 +0,0 @@ -New: Functions DoFAccessor::get_active_fe_indices() and -internal::DoFAccessorImplementation::get_active_vertex_fe_indices() -return all active finite element indices on the corresponding object. -
-(Marc Fehling, 2018/10/08) diff --git a/doc/news/changes/minor/20181013JonathanMatthews b/doc/news/changes/minor/20181013JonathanMatthews deleted file mode 100644 index 130b22a8c5..0000000000 --- a/doc/news/changes/minor/20181013JonathanMatthews +++ /dev/null @@ -1,4 +0,0 @@ -Fixed: The project_boundary_values_div_conforming() function now works correctly -with parallel::distributed::Triangulation. -
-(Jonathan Matthews, 2018/10/13) diff --git a/doc/news/changes/minor/20181017MarcFehling b/doc/news/changes/minor/20181017MarcFehling deleted file mode 100644 index 61f020bbaa..0000000000 --- a/doc/news/changes/minor/20181017MarcFehling +++ /dev/null @@ -1,5 +0,0 @@ -New: Classes FESeries::Fourier and FESeries::Legendre now take two -template arguments dim and spacedim, which allow them to use corresponding -hp::FECollection objects. -
-(Marc Fehling, 2018/10/17) diff --git a/doc/news/changes/minor/20181023DenisDavydov b/doc/news/changes/minor/20181023DenisDavydov deleted file mode 100644 index e96dcd0221..0000000000 --- a/doc/news/changes/minor/20181023DenisDavydov +++ /dev/null @@ -1,4 +0,0 @@ -New: Add Functions::IncrementalFunction which returns the difference in values of -a given function at two time steps. -
-(Denis Davydov, Jean-Paul Pelteret, 2018/10/05) diff --git a/doc/news/changes/minor/20181101Bangerth b/doc/news/changes/minor/20181101Bangerth deleted file mode 100644 index 14606b8ee4..0000000000 --- a/doc/news/changes/minor/20181101Bangerth +++ /dev/null @@ -1,5 +0,0 @@ -Fixed: SparsityPattern::begin() and DynamicSparsityPattern::begin() -resulted in an invalid iterator if the sparsity pattern was actually -empty. -
-(Wolfgang Bangerth, Denis Davydov, 2018/11/01) diff --git a/doc/news/changes/minor/20181102DanielArndt b/doc/news/changes/minor/20181102DanielArndt deleted file mode 100644 index 5e15b9007f..0000000000 --- a/doc/news/changes/minor/20181102DanielArndt +++ /dev/null @@ -1,6 +0,0 @@ -Changed: The class Subscriptor and SmartPointer check for dangling pointers and -use-after-move. The destructor of Subscriptor doesn't signal an error when there -is still an object subscribed to it. Instead, validity is checked when -dereferencing the SmartPointer object. -
-(Daniel Arndt, 2018/11/02) diff --git a/doc/news/changes/minor/20181103DavidWells b/doc/news/changes/minor/20181103DavidWells deleted file mode 100644 index 3352b1f360..0000000000 --- a/doc/news/changes/minor/20181103DavidWells +++ /dev/null @@ -1,4 +0,0 @@ -Fixed: The grid generated by GridGenerator::truncated_cone now uses more level 0 -cells to improve conditioning of cells when they are refined. -
-(David Wells, 2018/11/03) diff --git a/doc/news/changes/minor/20181104DanielArndt b/doc/news/changes/minor/20181104DanielArndt deleted file mode 100644 index 0164713298..0000000000 --- a/doc/news/changes/minor/20181104DanielArndt +++ /dev/null @@ -1,4 +0,0 @@ -Improved: GridIn::read_msh also support version 4 of MSH file format -extracting the same information as for the older versions. -
-(Daniel Arndt, 2018/11/04) diff --git a/doc/news/changes/minor/20181104DanielArndt-1 b/doc/news/changes/minor/20181104DanielArndt-1 deleted file mode 100644 index 4380729e7c..0000000000 --- a/doc/news/changes/minor/20181104DanielArndt-1 +++ /dev/null @@ -1,5 +0,0 @@ -Improved: The class ArrayView checks the memory location of the data it presents -and gained a template parameter indicating whether the data is stored in CPU or -CUDA memory. -
-(Daniel Arndt, 2018/11/04) diff --git a/doc/news/changes/minor/20181107LucaHeltai b/doc/news/changes/minor/20181107LucaHeltai deleted file mode 100644 index a14f128d3f..0000000000 --- a/doc/news/changes/minor/20181107LucaHeltai +++ /dev/null @@ -1,6 +0,0 @@ -New: GridOut::write_vtk and GridIn::read_vtk are now compatible with each other, and can be used to save -and restore a Triangulation with all manifold_ids and boundary_ids correctly saved. -This is now the only format that supports both boundary_id and manifold_id both in reading and writing. -
-(Luca Heltai, 2018/11/07) - diff --git a/doc/news/changes/minor/20181110DanielArndt b/doc/news/changes/minor/20181110DanielArndt deleted file mode 100644 index 8242438cb5..0000000000 --- a/doc/news/changes/minor/20181110DanielArndt +++ /dev/null @@ -1,4 +0,0 @@ -Deprecated: The binary Tecplot output using the DataOutBase::tecplot_binary -format has been deprecated. -
-(Daniel Arndt, 2018/11/10) diff --git a/doc/news/changes/minor/20181110MartinKronbichler b/doc/news/changes/minor/20181110MartinKronbichler deleted file mode 100644 index 1a6b2fdd7e..0000000000 --- a/doc/news/changes/minor/20181110MartinKronbichler +++ /dev/null @@ -1,5 +0,0 @@ -Fixed: The operation FEEvaluation::read_dof_values performed invalid array -accesses with AVX512 vectorization in rare circumstances of particular 1d -meshes. This is now fixed. -
-(Martin Kronbichler, 2018/11/10) diff --git a/doc/news/changes/minor/20181111DavidWells b/doc/news/changes/minor/20181111DavidWells deleted file mode 100644 index 9b95b3b3fa..0000000000 --- a/doc/news/changes/minor/20181111DavidWells +++ /dev/null @@ -1,5 +0,0 @@ -New: A new function GridTools::get_coarse_mesh_description has been added. This -function extracts the vertices, CellData, and SubCellData objects from a -Triangulation (i.e., it is the inverse of Triangulation::create_triangulation). -
-(David Wells, 2018/11/11) diff --git a/doc/news/changes/minor/20181119AlexanderGrayver b/doc/news/changes/minor/20181119AlexanderGrayver deleted file mode 100644 index cd68c8e46d..0000000000 --- a/doc/news/changes/minor/20181119AlexanderGrayver +++ /dev/null @@ -1,3 +0,0 @@ -Fix bug with FEFaceValues initialization when used with the FE_NedelecSZ -
-(Alexander Grayver, 2018/11/19) diff --git a/doc/news/changes/minor/20181120Bangerth b/doc/news/changes/minor/20181120Bangerth deleted file mode 100644 index 5033fce69c..0000000000 --- a/doc/news/changes/minor/20181120Bangerth +++ /dev/null @@ -1,6 +0,0 @@ -Fixed: The TriaAccessor<0,dim,spacedim> and TriaAccessor<0,1,spacedim> -classes were missing member functions `get_triangulation()` and -`operator<()`. This prevented these objects from being stored in -`std::map`s, among other issues. -
-(Wolfgang Bangerth, Luca Heltai, 2018/11/20) diff --git a/doc/news/changes/minor/20181121BrunoTurcksin b/doc/news/changes/minor/20181121BrunoTurcksin deleted file mode 100644 index 5880f57391..0000000000 --- a/doc/news/changes/minor/20181121BrunoTurcksin +++ /dev/null @@ -1,4 +0,0 @@ -New: Add support for MPI when using CUDAWrappers::MatrixFree. This only works -with LinearAlgebra::distributed::Vector -
-(Bruno Turcksin, 2018/11/21) diff --git a/doc/news/changes/minor/20181122LucaHeltai b/doc/news/changes/minor/20181122LucaHeltai deleted file mode 100644 index 2ae5b5780b..0000000000 --- a/doc/news/changes/minor/20181122LucaHeltai +++ /dev/null @@ -1,5 +0,0 @@ -New: Triangulation::n_faces, Triangulation::n_active_faces, and Triangulation::n_raw_faces now work also -in one dimension. -
-(Luca Heltai, 2018/11/22) - diff --git a/doc/news/changes/minor/20181128MartinKronbichler b/doc/news/changes/minor/20181128MartinKronbichler deleted file mode 100644 index fed3c5d825..0000000000 --- a/doc/news/changes/minor/20181128MartinKronbichler +++ /dev/null @@ -1,4 +0,0 @@ -Fixed: The MatrixFree::initialize() function would sometimes run into an -assertion when ghost faces occur on subdomain interfaces. This is now fixed. -
-(Martin Kronbichler, 2018/11/28) diff --git a/doc/news/changes/minor/20181130DavidWells b/doc/news/changes/minor/20181130DavidWells deleted file mode 100644 index 7c588398a5..0000000000 --- a/doc/news/changes/minor/20181130DavidWells +++ /dev/null @@ -1,5 +0,0 @@ -New: A new header deal.II/base/undefine_macros.h has been -added. This header, as the name suggests, undefines all deal.II macros that are -not prefixed with either DEAL or deal. -
-(David Wells, 2018/11/30) diff --git a/doc/news/changes/minor/20181130StefanoDominici b/doc/news/changes/minor/20181130StefanoDominici deleted file mode 100644 index 1c4caab11b..0000000000 --- a/doc/news/changes/minor/20181130StefanoDominici +++ /dev/null @@ -1,5 +0,0 @@ -New: Class EllipticalManifold derived from ChartManifold, -valid only for dim=2 and spacedim=2. It maps points from a system of -cartesian coordinates to a system of elliptical coordinates and vice-versa. -
-(Stefano Dominici, 2018/11/30) diff --git a/doc/news/changes/minor/20181203LucaHeltai b/doc/news/changes/minor/20181203LucaHeltai deleted file mode 100644 index 1d469e3738..0000000000 --- a/doc/news/changes/minor/20181203LucaHeltai +++ /dev/null @@ -1,4 +0,0 @@ -New: Added entries to GridTools::Cache to build a vertices RTree, and a bounding boxes RTree. -
-(Luca Heltai, 2018/12/03) - diff --git a/doc/news/changes/minor/20181204Fehling b/doc/news/changes/minor/20181204Fehling deleted file mode 100644 index 6fbb83551a..0000000000 --- a/doc/news/changes/minor/20181204Fehling +++ /dev/null @@ -1,6 +0,0 @@ -Changed: FESeries::Fourier::calculate and FESeries::Legendre::calculate -accept both Vector and Vector as input parameters for -local dof values. -
-(Marc Fehling, 2018/12/04) - diff --git a/doc/news/changes/minor/20181205DenisDavydov-1 b/doc/news/changes/minor/20181205DenisDavydov-1 deleted file mode 100644 index cd4052cceb..0000000000 --- a/doc/news/changes/minor/20181205DenisDavydov-1 +++ /dev/null @@ -1,3 +0,0 @@ -New: Add DEAL_II_LAPACK_WITH_MKL macro which will be set if Intel MKL is being used. -
-(Denis Davydov, 2018/12/05) diff --git a/doc/news/changes/minor/20181205DenisDavydov-2 b/doc/news/changes/minor/20181205DenisDavydov-2 deleted file mode 100644 index 8e2a5415c8..0000000000 --- a/doc/news/changes/minor/20181205DenisDavydov-2 +++ /dev/null @@ -1,3 +0,0 @@ -New: Add LAPACKFullMatrix::transpose() to perform out-of-place transposition. -
-(Denis Davydov, 2018/12/05) diff --git a/doc/news/changes/minor/20181205LucaHeltai b/doc/news/changes/minor/20181205LucaHeltai deleted file mode 100644 index 126f5cb3a2..0000000000 --- a/doc/news/changes/minor/20181205LucaHeltai +++ /dev/null @@ -1,9 +0,0 @@ -New: GridTools::find_active_cell_around_point now allows you to specify an (optional) rtree, constructed -from the used vertices of the triangulation. Once you have built a tree, querying for a nearest -vertex is an O(log(N)) operation, where N is the number of used vertices. You can ask a GridTools::Cache -object to return a tree that is compatible with the new function signature. -The previous version of this function had a cost that was O(N^2) when the point was not in the cell_hint -object. -
-(Luca Heltai, 2018/12/05) - diff --git a/doc/news/changes/minor/20181210BrunoTurcksin b/doc/news/changes/minor/20181210BrunoTurcksin deleted file mode 100644 index 804b726223..0000000000 --- a/doc/news/changes/minor/20181210BrunoTurcksin +++ /dev/null @@ -1,4 +0,0 @@ -New: Add helpers functions to use varying coefficients when using -CUDAWrappers::MatrixFree. -
-(Bruno Turcksin, 2018/12/10) diff --git a/doc/news/changes/minor/20181217GiovanniAlzetta b/doc/news/changes/minor/20181217GiovanniAlzetta deleted file mode 100644 index 9e40685ce2..0000000000 --- a/doc/news/changes/minor/20181217GiovanniAlzetta +++ /dev/null @@ -1,6 +0,0 @@ -New: Function GridTools::build_global_description_tree which exchanges a given -vector of bounding boxes on all processes and uses the result to build an Rtree -with packing algorithm. -
-(Giovanni Alzetta, 2018/12/17) - diff --git a/doc/news/changes/minor/20181218MarcFehling b/doc/news/changes/minor/20181218MarcFehling deleted file mode 100644 index b11458c694..0000000000 --- a/doc/news/changes/minor/20181218MarcFehling +++ /dev/null @@ -1,4 +0,0 @@ -New: Class parallel::distributed::CellDataTransfer has been introduced to transfer -cell by cell data across distributed meshes in case of refinement/serialization. -
-(Marc Fehling, 2018/12/18) diff --git a/doc/news/changes/minor/20181219DanielJodlbauer b/doc/news/changes/minor/20181219DanielJodlbauer deleted file mode 100644 index 50e87bbf8b..0000000000 --- a/doc/news/changes/minor/20181219DanielJodlbauer +++ /dev/null @@ -1,3 +0,0 @@ -Fixed: Reinit blockvector only when necessary in MGTransferBlockMatrixFree::copy_to_mg. -
-(Daniel Jodlbauer, 2018/12/19) diff --git a/doc/news/changes/minor/20181222DanielArndt b/doc/news/changes/minor/20181222DanielArndt deleted file mode 100644 index d5f19b9ef6..0000000000 --- a/doc/news/changes/minor/20181222DanielArndt +++ /dev/null @@ -1,8 +0,0 @@ -Replaced: TrilinosWrappers::MPI::Vector::vector_partitioner() has been -deprecated in favor of TrilinosWrappers::MPI::Vector::trilinos_partitioner(). -The latter one returns an Epetra_BlockMap instead of an Epetra_Map avoiding an -invalid downcast. -The IndexSet constructor taking an Epetra_Map object has been replaced to -accept a base class object of type Epetra_BlockMap instead. -
-(Daniel Arndt, 2018/12/22) diff --git a/doc/news/changes/minor/20181226DenisDavydov b/doc/news/changes/minor/20181226DenisDavydov deleted file mode 100644 index e40be830d6..0000000000 --- a/doc/news/changes/minor/20181226DenisDavydov +++ /dev/null @@ -1,3 +0,0 @@ -New: Add SolverBFGS to minimize a function using the limited memory BFGS approach. -
-(Denis Davydov, 2018/12/26) diff --git a/doc/news/changes/minor/20181230DenisDavydov b/doc/news/changes/minor/20181230DenisDavydov deleted file mode 100644 index e5cc0b0af5..0000000000 --- a/doc/news/changes/minor/20181230DenisDavydov +++ /dev/null @@ -1,4 +0,0 @@ -New: Add LAPACKFullMatrix::apply_givens_rotation() and Vector::apply_givens_rotation() to -apply a Givens rotation matrix. -
-(Denis Davydov, 2018/12/30) diff --git a/doc/news/changes/minor/20190104ArndtTurcksin b/doc/news/changes/minor/20190104ArndtTurcksin deleted file mode 100644 index 9c74f08b9b..0000000000 --- a/doc/news/changes/minor/20190104ArndtTurcksin +++ /dev/null @@ -1,4 +0,0 @@ -New: LinearAlgebra::distributed::Vector with CUDA memory space uses CUDA-aware -MPI in case deal.II is configured with DEAL_II_MPI_WITH_CUDA_SUPPORT=ON. -
-(Daniel Arndt, Bruno Turcksin, 2019/01/04) diff --git a/doc/news/changes/minor/20190108Fehling b/doc/news/changes/minor/20190108Fehling deleted file mode 100644 index 804f400a80..0000000000 --- a/doc/news/changes/minor/20190108Fehling +++ /dev/null @@ -1,5 +0,0 @@ -Fixed: Tensor indices of set_k_vectors() in FESeries::Fourier. -Coefficients will now be distributed in every -coordinate direction correctly. -
-(Marc Fehling, 2019/01/08) diff --git a/doc/news/changes/minor/20190111GiovanniAlzetta b/doc/news/changes/minor/20190111GiovanniAlzetta deleted file mode 100644 index 868aee927f..0000000000 --- a/doc/news/changes/minor/20190111GiovanniAlzetta +++ /dev/null @@ -1,5 +0,0 @@ -New: GridTools::Cache::get_covering_rtree() automatically stores and generates -a rtree of bounding boxes covering the whole triangulation. In a distributed setting -it can identify which processes have locally owned cells in any part of the mesh. -
-(Giovanni Alzetta, 2019/01/11) diff --git a/doc/news/changes/minor/20190113VishalBoddu b/doc/news/changes/minor/20190113VishalBoddu deleted file mode 100644 index 4017c4f4f3..0000000000 --- a/doc/news/changes/minor/20190113VishalBoddu +++ /dev/null @@ -1,4 +0,0 @@ -New: Indentation script deal.II/contrib/utilities/indent.py is added -to format code in external projects that use deal.II -
-(Vishal Boddu, 2019/01/13) diff --git a/doc/news/changes/minor/20190118DenisDavydov b/doc/news/changes/minor/20190118DenisDavydov deleted file mode 100644 index 5492238df4..0000000000 --- a/doc/news/changes/minor/20190118DenisDavydov +++ /dev/null @@ -1,5 +0,0 @@ -New: Add default constructor to DynamicSparsityPatternIterators::Accessor() and -DynamicSparsityPatternIterators::Iterator() to be able to store such objects -in STL containers. -
-(Denis Davydov, 2019/01/18) diff --git a/doc/news/changes/minor/20190125Jean-PaulPelteret b/doc/news/changes/minor/20190125Jean-PaulPelteret deleted file mode 100644 index a6a2c3d7d1..0000000000 --- a/doc/news/changes/minor/20190125Jean-PaulPelteret +++ /dev/null @@ -1,8 +0,0 @@ -Improved: A new dummy enumeration AD::NumberTypes::none has been added. -It exists to represent number types that are scalar arithmetic types, -i.e those that hold no derivatives. They are implemented primarily to -facilitate the use of template meta-programming techniques to switch -between different AD types. This covers the case when the user does not -want an AD type at all, but rather a primitive type. -
-(Jean-Paul Pelteret, 2019/01/25) diff --git a/doc/news/changes/minor/20190130DenisDavydov b/doc/news/changes/minor/20190130DenisDavydov deleted file mode 100644 index 4cf4ec962c..0000000000 --- a/doc/news/changes/minor/20190130DenisDavydov +++ /dev/null @@ -1,4 +0,0 @@ -New: Add internal::MatrixFreeFunctions::DoFInfo::get_dof_indices_on_cell_batch() to -return locally owned DoFs used by matrix-free framework on a given cell. -
-(Denis Davydov, 2019/01/30) diff --git a/doc/news/changes/minor/20190130GiovanniAlzetta b/doc/news/changes/minor/20190130GiovanniAlzetta deleted file mode 100644 index a9b64415e3..0000000000 --- a/doc/news/changes/minor/20190130GiovanniAlzetta +++ /dev/null @@ -1,5 +0,0 @@ -Changed: Function GridGenerator::general_cell() can now generate -a cell of dimension `dim` inside a space of dimension `spacedim` -with `dim <= spacedim` -
-(Giovanni Alzetta, 2019/01/30) diff --git a/doc/news/changes/minor/20190131GiovanniAlzettaDanielArndtWolfgangBangerth b/doc/news/changes/minor/20190131GiovanniAlzettaDanielArndtWolfgangBangerth deleted file mode 100644 index 882d29c7cb..0000000000 --- a/doc/news/changes/minor/20190131GiovanniAlzettaDanielArndtWolfgangBangerth +++ /dev/null @@ -1,4 +0,0 @@ -New: added constructor to the class Point, which converts -a boost::geometry::model::point to a dealii::Point -
-(Giovanni Alzetta, Daniel Arndt, Wolfgang Bangerth, 2019/01/31) diff --git a/doc/news/changes/minor/20190202Arndt b/doc/news/changes/minor/20190202Arndt deleted file mode 100644 index a3357d6bf4..0000000000 --- a/doc/news/changes/minor/20190202Arndt +++ /dev/null @@ -1,3 +0,0 @@ -Documented: The minimal supported MPI version is MPI-2.0. -
-(Daniel Arndt, 2019/02/02) diff --git a/doc/news/changes/minor/20190205MartinKronbichler b/doc/news/changes/minor/20190205MartinKronbichler deleted file mode 100644 index 711b9588df..0000000000 --- a/doc/news/changes/minor/20190205MartinKronbichler +++ /dev/null @@ -1,7 +0,0 @@ -Fixed: MGLevelGlobalTransfer::copy_to_mg would initialize the level vectors -without ghosts. When combined with Chebyshev smoother and a DiagonalMatrix as -well as specific matrix-free loops, this could lead to ghosted vectors in -places where they were not supposed to be ghosted, leading to exceptions. This -is now fixed. -
-(Martin Kronbichler, 2019/02/05) diff --git a/doc/news/changes/minor/20190206DenisDavydov b/doc/news/changes/minor/20190206DenisDavydov deleted file mode 100644 index 73aa3ed586..0000000000 --- a/doc/news/changes/minor/20190206DenisDavydov +++ /dev/null @@ -1,4 +0,0 @@ -Improved: Use binary search in BlockIndices::global_to_local() to improve performance -for large number of blocks. -
-(Denis Davydov, 2019/02/06) diff --git a/doc/news/changes/minor/20190206MartinKronbichler b/doc/news/changes/minor/20190206MartinKronbichler deleted file mode 100644 index ef651a9a66..0000000000 --- a/doc/news/changes/minor/20190206MartinKronbichler +++ /dev/null @@ -1,9 +0,0 @@ -Improved: The FEEvaluation::evaluate() and FEEvaluation::integrate() routines -would previously unconditionally use an evaluation routine with a -transformation to a collocation basis and subsequent collocation derivative -for `n_q_points_1d > fe_degree` because it is faster for the usual case of -`n_q_points_1d` close to the polynomial degree. Now, we switch back to the -standard evaluation if `n_q_points_1d > 3 * (fe_degree+1) / 2` where that -variant is faster. -
-(Martin Kronbichler, 2019/02/06) diff --git a/doc/news/changes/minor/20190207MartinKronbichler b/doc/news/changes/minor/20190207MartinKronbichler deleted file mode 100644 index 3785b7f5ab..0000000000 --- a/doc/news/changes/minor/20190207MartinKronbichler +++ /dev/null @@ -1,5 +0,0 @@ -Improved: The iteration of PreconditionChebyshev has been overhauled to reduce -the number of vectors written per iteration to one, leading to slightly faster -execution of the vector updates. -
-(Martin Kronbichler, 2019/02/07) diff --git a/doc/news/changes/minor/20190208DenisDavydov b/doc/news/changes/minor/20190208DenisDavydov deleted file mode 100644 index 3d8c7ce6cd..0000000000 --- a/doc/news/changes/minor/20190208DenisDavydov +++ /dev/null @@ -1,3 +0,0 @@ -New: Add default constructor to SparsityPatternIterators::Accessor(). -
-(Denis Davydov, 2019/02/08) diff --git a/doc/news/changes/minor/20190208MartinKronbichler b/doc/news/changes/minor/20190208MartinKronbichler deleted file mode 100644 index 3a12e97374..0000000000 --- a/doc/news/changes/minor/20190208MartinKronbichler +++ /dev/null @@ -1,8 +0,0 @@ -Fixed: PreconditionChebyshev would previously run one iteration more than -requested, i.e., perform `degree+1` matrix-vector products rather than -`degree` which is the convention in literature. This is now fixed. Note that -the quality of PreconditionChebyshev is obviously slightly reduced by this -change, and some solvers might need more outer iterations due to a ligher -Chebyshev iteration. -
-(Martin Kronbichler, 2019/02/08) diff --git a/doc/news/changes/minor/20190209Arndt b/doc/news/changes/minor/20190209Arndt deleted file mode 100644 index b781c43943..0000000000 --- a/doc/news/changes/minor/20190209Arndt +++ /dev/null @@ -1,3 +0,0 @@ -New: make_const_array_view() creates a constant view from a non-const object. -
-(Daniel Arndt, 2019/02/09) diff --git a/doc/news/changes/minor/20190210MarcFehling b/doc/news/changes/minor/20190210MarcFehling deleted file mode 100644 index ab3127585a..0000000000 --- a/doc/news/changes/minor/20190210MarcFehling +++ /dev/null @@ -1,6 +0,0 @@ -New: Member functions DoFHandler::set_fe() and hp::DoFHandler::set_fe() -that will register a finite element object without enumerating all -degrees of freedom. In the hp case, the active_fe_indices will be -initialized and communicated amongst all processors, additionally. -
-(Marc Fehling, 2019/02/10) diff --git a/doc/news/changes/minor/20190211ConradClevenger b/doc/news/changes/minor/20190211ConradClevenger deleted file mode 100644 index da07b583e6..0000000000 --- a/doc/news/changes/minor/20190211ConradClevenger +++ /dev/null @@ -1,6 +0,0 @@ -New: Function MGConstrainedDoFs::make_no_normal_flux_constraints which adds -functionality for no normal flux constraints during geometric mutigrid computations. -Currently, this function is limited to meshes with no normal flux boundaries -normal to the x-, y-, or z-axis. -
-(Conrad Clevenger, 2019/02/11) diff --git a/doc/news/changes/minor/20190213MatthiasMaier b/doc/news/changes/minor/20190213MatthiasMaier deleted file mode 100644 index 4307beeed4..0000000000 --- a/doc/news/changes/minor/20190213MatthiasMaier +++ /dev/null @@ -1,5 +0,0 @@ -Fixed: inverse_operator() now handles a (composite) LinearOperator, the -temporary PreconditionIdentity(), or no argument as preconditioner argument -correctly. -
-(Matthias Maier, 2019/02/13) diff --git a/doc/news/changes/minor/20190213SebastianStark b/doc/news/changes/minor/20190213SebastianStark deleted file mode 100644 index 44710517f5..0000000000 --- a/doc/news/changes/minor/20190213SebastianStark +++ /dev/null @@ -1,3 +0,0 @@ -Fixed: Handle the case properly that a local matrix with all diagonal elements equal to zero is distributed with AffineConstraints::distribute_local_to_global() to the global matrix while constraints apply. -
-(Sebastian Stark, 2019/02/13) diff --git a/doc/news/changes/minor/20190219ConradClevenger b/doc/news/changes/minor/20190219ConradClevenger deleted file mode 100644 index aa560d10d9..0000000000 --- a/doc/news/changes/minor/20190219ConradClevenger +++ /dev/null @@ -1,4 +0,0 @@ -New: Function DoFRenumbering::random(dof_handler, level) which allows for a random renumbering -of degrees of freedom on a level in a mutilevel hierarchy. -
-(Conrad Clevenger, 2019/02/19) diff --git a/doc/news/changes/minor/20190221MartinKronbichler b/doc/news/changes/minor/20190221MartinKronbichler deleted file mode 100644 index e22a5b8f6b..0000000000 --- a/doc/news/changes/minor/20190221MartinKronbichler +++ /dev/null @@ -1,6 +0,0 @@ -Fixed: FEFaceEvaluation::evaluate() and FEFaceEvaluation::integrate() would -provide wrong results for faces in non-standard orientation layout, namely -with `orientation=true, face_flip={false,true}, face_rotation=true`. This is -now fixed. -
-(Martin Kronbichler, 2019/02/21) diff --git a/doc/news/changes/minor/20190225GiovanniAlzetta b/doc/news/changes/minor/20190225GiovanniAlzetta deleted file mode 100644 index e5c653343e..0000000000 --- a/doc/news/changes/minor/20190225GiovanniAlzetta +++ /dev/null @@ -1,4 +0,0 @@ -New: Function GridTools::guess_point_owner(), which uses a covering rtree -to guess which processes own the points of the given vector of points. -
-(Giovanni Alzetta, 2019/02/25) diff --git a/doc/news/changes/minor/20190227DanielJodlbauer b/doc/news/changes/minor/20190227DanielJodlbauer deleted file mode 100644 index a7afb2bcae..0000000000 --- a/doc/news/changes/minor/20190227DanielJodlbauer +++ /dev/null @@ -1,3 +0,0 @@ -Fixed: Tensor-valued pvtu output. -
-(Daniel Jodlbauer, 2019/02/27) diff --git a/doc/news/changes/minor/20190228Fehling b/doc/news/changes/minor/20190228Fehling deleted file mode 100644 index 85c0089d88..0000000000 --- a/doc/news/changes/minor/20190228Fehling +++ /dev/null @@ -1,7 +0,0 @@ -New: Hierarchy of finite elements in hp::FECollection objects. Get succeeding -and preceding indices via hp::FECollection::next_in_hierarchy() and -hp::FECollection::prev_in_hierarchy(). By default, a hierarchy corresponding -to indices is established. Hierarchy can be overridden via -hp::FECollection::set_hierarchy(). -
-(Marc Fehling, 2019/02/28) diff --git a/doc/news/changes/minor/20190302ArndtStark b/doc/news/changes/minor/20190302ArndtStark deleted file mode 100644 index 5b720d590c..0000000000 --- a/doc/news/changes/minor/20190302ArndtStark +++ /dev/null @@ -1,4 +0,0 @@ -Fixed: CellAccessor::material_id interfered with the manifold object -for refining the mesh in case its dimension was less than the space dimension. -
-(Daniel Arndt, Sebastian Stark, 2019/03/02) diff --git a/doc/news/changes/minor/20190303Fehling b/doc/news/changes/minor/20190303Fehling deleted file mode 100644 index 5bcb949a02..0000000000 --- a/doc/news/changes/minor/20190303Fehling +++ /dev/null @@ -1,5 +0,0 @@ -New: Signals Triangulation::pre_distributed_repartition and -Triangulation::post_distributed_repartition which will be triggered in -parallel::distributed::Triangulation::repartition(). -
-(Marc Fehling, 2019/03/03) diff --git a/doc/news/changes/minor/20190304DavidWells b/doc/news/changes/minor/20190304DavidWells deleted file mode 100644 index b0cd08c43a..0000000000 --- a/doc/news/changes/minor/20190304DavidWells +++ /dev/null @@ -1,5 +0,0 @@ -Fixed: the DoFTools::make_sparsity_pattern variant that takes, as arguments, two -different DoFHandler objects now works correctly with -parallel::shared::Triangulation and parallel::distributed::Triangulation. -
-(David Wells, 2019/03/04) diff --git a/doc/news/changes/minor/20190305DanielAppelMartinKronbichler-1 b/doc/news/changes/minor/20190305DanielAppelMartinKronbichler-1 deleted file mode 100644 index e9604fb6dc..0000000000 --- a/doc/news/changes/minor/20190305DanielAppelMartinKronbichler-1 +++ /dev/null @@ -1,5 +0,0 @@ -Fixed: CylindricalManifold::get_new_point would previously return wrong -results if the resulting point is on the axis, and the cylinder axis does not -pass through the origin. -
-(Daniel Appel, Martin Kronbichler, 2019/03/05) diff --git a/doc/news/changes/minor/20190305DanielAppelMartinKronbichler-2 b/doc/news/changes/minor/20190305DanielAppelMartinKronbichler-2 deleted file mode 100644 index 2396b24c9e..0000000000 --- a/doc/news/changes/minor/20190305DanielAppelMartinKronbichler-2 +++ /dev/null @@ -1,4 +0,0 @@ -Fixed: EllipiticalManifold::push_forward_gradient did previously not take the -rotation into account. This is now fixed. -
-(Daniel Appel, Martin Kronbichler, 2019/03/05) diff --git a/doc/news/changes/minor/20190306BrunoTurcksin b/doc/news/changes/minor/20190306BrunoTurcksin deleted file mode 100644 index 5bbf2b5715..0000000000 --- a/doc/news/changes/minor/20190306BrunoTurcksin +++ /dev/null @@ -1,4 +0,0 @@ -Fixed: LinearAlgebra::CUDAWrappers::Vector::add_and_dot was giving a wrong result -if the size of vector was greater than 4096. -
-(Bruno Turcksin, 2018/03/06) diff --git a/doc/news/changes/minor/20190307LucaHeltai b/doc/news/changes/minor/20190307LucaHeltai deleted file mode 100644 index 3dc9cf177e..0000000000 --- a/doc/news/changes/minor/20190307LucaHeltai +++ /dev/null @@ -1,4 +0,0 @@ -New: Added a new function Utilities::type_to_string() to demangle type names. -
-(Luca Heltai, 2019/03/07) - diff --git a/doc/news/changes/minor/20190308MartinKronbichler b/doc/news/changes/minor/20190308MartinKronbichler deleted file mode 100644 index 714316a34d..0000000000 --- a/doc/news/changes/minor/20190308MartinKronbichler +++ /dev/null @@ -1,5 +0,0 @@ -Fixed: DoFHandler::renumber_dofs() called on levels would previously run into -an assertion on distributed triangulation when used with continuous -elements. This is now fixed. -
-(Martin Kronbichler, 2019/03/08) diff --git a/doc/news/changes/minor/20190310Jean-PaulPelteret-1 b/doc/news/changes/minor/20190310Jean-PaulPelteret-1 deleted file mode 100644 index 6030de9655..0000000000 --- a/doc/news/changes/minor/20190310Jean-PaulPelteret-1 +++ /dev/null @@ -1,6 +0,0 @@ -Changed: The TrilinosWrappers::PreconditionAMG::AdditionalData data structure -is now able to return a parameter list, which can be adjusted and fine-tuned by -the user and later used to initialize the AMG preconditioner. It can also -initialize the null space settings of an existing parameter list. -
-(Jean-Paul Pelteret, 2019/03/10) diff --git a/doc/news/changes/minor/20190311TimoHeister b/doc/news/changes/minor/20190311TimoHeister deleted file mode 100644 index db6c9bdafb..0000000000 --- a/doc/news/changes/minor/20190311TimoHeister +++ /dev/null @@ -1,3 +0,0 @@ -New: If present, we will detect the LLD linker ld.lld at configuration time. -
-(Timo Heister, 2019/03/11) diff --git a/doc/news/changes/minor/20190313LucaHeltai b/doc/news/changes/minor/20190313LucaHeltai deleted file mode 100644 index b3f47d11a6..0000000000 --- a/doc/news/changes/minor/20190313LucaHeltai +++ /dev/null @@ -1,6 +0,0 @@ -New: Added two new classes to the MeshWorker namespace: MeshWorker::ScratchData and -MeshWorker::CopyData, that can be used as good default classes with the -WorkStream::run() and MeshWorker::mesh_loop() functions. -
-(Luca Heltai, 2019/03/13) - diff --git a/doc/news/changes/minor/20190316Arndt b/doc/news/changes/minor/20190316Arndt deleted file mode 100644 index 204e05b914..0000000000 --- a/doc/news/changes/minor/20190316Arndt +++ /dev/null @@ -1,4 +0,0 @@ -Improved: The apply_all_indicators_to_manifold flag in GridIn::read_ucd() -lets the indicators be used for cells as manifold id as well. -
-(Daniel Arndt, 2019/03/16) diff --git a/doc/news/changes/minor/20190316DenisDavydov b/doc/news/changes/minor/20190316DenisDavydov deleted file mode 100644 index 7d018538b7..0000000000 --- a/doc/news/changes/minor/20190316DenisDavydov +++ /dev/null @@ -1,3 +0,0 @@ -Improved: DoFRenumbering::cell_wise() now support parallel::Triangulation . -
-(Denis Davydov, 2019/03/16) diff --git a/doc/news/changes/minor/20190316SebastianStark b/doc/news/changes/minor/20190316SebastianStark deleted file mode 100644 index d58ad0b7d8..0000000000 --- a/doc/news/changes/minor/20190316SebastianStark +++ /dev/null @@ -1,4 +0,0 @@ -New: VectorTools::interpolate_to_different_mesh() now works with -hp::DoFHandler objects. -
-(Sebastian Stark, 2019/03/16) diff --git a/doc/news/changes/minor/20190319DenisDavydov b/doc/news/changes/minor/20190319DenisDavydov deleted file mode 100644 index ab8f90eec8..0000000000 --- a/doc/news/changes/minor/20190319DenisDavydov +++ /dev/null @@ -1,4 +0,0 @@ -New: Add Utilities::MPI::create_ascending_partitioning() to create a one-to-one -ascending partitioning from locally owned sizes. -
-(Denis Davydov, 2019/03/19) diff --git a/doc/news/changes/minor/20190319DenisDavydov_b b/doc/news/changes/minor/20190319DenisDavydov_b deleted file mode 100644 index 7f728e91ef..0000000000 --- a/doc/news/changes/minor/20190319DenisDavydov_b +++ /dev/null @@ -1,3 +0,0 @@ -New: Add SparsityTools::gather_sparsity_pattern(). -
-(Denis Davydov, 2019/03/19) diff --git a/doc/news/changes/minor/20190319LucaHeltai b/doc/news/changes/minor/20190319LucaHeltai deleted file mode 100644 index 5328898f64..0000000000 --- a/doc/news/changes/minor/20190319LucaHeltai +++ /dev/null @@ -1,4 +0,0 @@ -New: FEValuesExtractor classes now have a new method get_name() that returns a unique string identifier -for each extractor. -
-(Luca Heltai, 2019/03/19) diff --git a/doc/news/changes/minor/20190319LucaHeltai_b b/doc/news/changes/minor/20190319LucaHeltai_b deleted file mode 100644 index c41dc60477..0000000000 --- a/doc/news/changes/minor/20190319LucaHeltai_b +++ /dev/null @@ -1,5 +0,0 @@ -New: The new method GridTools::assign_co_dimensional_manifold_indicators() propagate manifold ids from -cells to faces and edges, according to a disambiguation function that takes the set of manifold ids of -the cells that share the given face or edge. -
-(Luca Heltai, 2019/03/19) diff --git a/doc/news/changes/minor/20190320DenisDavydov b/doc/news/changes/minor/20190320DenisDavydov deleted file mode 100644 index fa9905b7e4..0000000000 --- a/doc/news/changes/minor/20190320DenisDavydov +++ /dev/null @@ -1,4 +0,0 @@ -New: Add DynamicSparsityPattern::nonempty_cols()/DynamicSparsityPattern::nonempty_rows() to return columns/rows -stored in the sparsity pattern. -
-(Denis Davydov, 2019/03/20) diff --git a/doc/news/changes/minor/20190320LucaHeltai b/doc/news/changes/minor/20190320LucaHeltai deleted file mode 100644 index 5d1cbf85cf..0000000000 --- a/doc/news/changes/minor/20190320LucaHeltai +++ /dev/null @@ -1,5 +0,0 @@ -New: The type alias FEValuesViews::View now allows one to infer the correct FEValuesViews type -that would be returned by FEValuesBase::operator[]() when called with a specified extractor type from the -FEValuesExtractors namespace. -
-(Luca Heltai, 2019/03/20) diff --git a/doc/news/changes/minor/20190323LucaHeltai b/doc/news/changes/minor/20190323LucaHeltai deleted file mode 100644 index d4b08ab3de..0000000000 --- a/doc/news/changes/minor/20190323LucaHeltai +++ /dev/null @@ -1,4 +0,0 @@ -New: Added a variant of MeshWorker::mesh_loop() that takes a class and its member functions as workers -and copiers. -
-(Luca Heltai, 2019/03/23) diff --git a/doc/news/changes/minor/20190326Arndt b/doc/news/changes/minor/20190326Arndt deleted file mode 100644 index 6d4bd85a73..0000000000 --- a/doc/news/changes/minor/20190326Arndt +++ /dev/null @@ -1,5 +0,0 @@ -Changed: parallel::distributed::SolutionTransfer::prepare_serialization() has -been deprecated in favor of -parallel::distributed::SolutionTransfer::prepare_for_serialization(). -
-(Daniel Arndt, 2019/03/26) diff --git a/doc/news/changes/minor/20190328Bangerth b/doc/news/changes/minor/20190328Bangerth deleted file mode 100644 index e53f939f72..0000000000 --- a/doc/news/changes/minor/20190328Bangerth +++ /dev/null @@ -1,5 +0,0 @@ -New: The Vector class can now be initialized using an object of type -std::initializer_list. Such objects are, in particular, created when -the compiler sees a brace-enclosed list of numbers. -
-(Wolfgang Bangerth, 2019/03/28) diff --git a/doc/news/changes/minor/20190330Jean-PaulPelteret b/doc/news/changes/minor/20190330Jean-PaulPelteret deleted file mode 100644 index 22364ffafe..0000000000 --- a/doc/news/changes/minor/20190330Jean-PaulPelteret +++ /dev/null @@ -1,4 +0,0 @@ -New: The Differentiation::SD::Expression class can now be used to perform -symbolic math calculations. -
-(Jean-Paul Pelteret, 2019/03/30) diff --git a/doc/news/changes/minor/20190402DenisDavydov b/doc/news/changes/minor/20190402DenisDavydov deleted file mode 100644 index a2d7537d67..0000000000 --- a/doc/news/changes/minor/20190402DenisDavydov +++ /dev/null @@ -1,3 +0,0 @@ -New: Add ArraView::ArrayView() and ArrayView::reinit(value_type *, const std::size_t). -
-(Denis Davydov, 2019/04/02) diff --git a/doc/news/changes/minor/20190402LucaHeltaiJean-PaulPelteret b/doc/news/changes/minor/20190402LucaHeltaiJean-PaulPelteret deleted file mode 100644 index 942968300a..0000000000 --- a/doc/news/changes/minor/20190402LucaHeltaiJean-PaulPelteret +++ /dev/null @@ -1,5 +0,0 @@ -New: The GeneralDataStorage class facilitates the storage of any general data. -It offers the ability to store any amount of data, of any type, which is then -made accessible by an identifier string. -
-(Luca Heltai, Jean-Paul Pelteret, 2019/04/02) diff --git a/doc/news/changes/minor/20190408Arndt b/doc/news/changes/minor/20190408Arndt deleted file mode 100644 index eaf8cc5e3f..0000000000 --- a/doc/news/changes/minor/20190408Arndt +++ /dev/null @@ -1,4 +0,0 @@ -Changed: SmartPointer and Subscriptor use a std::string -instead of a const char * as identifier. -
-(Daniel Arndt, 2019/04/08) diff --git a/doc/news/changes/minor/20190408MarcFehling b/doc/news/changes/minor/20190408MarcFehling deleted file mode 100644 index f60e1c7118..0000000000 --- a/doc/news/changes/minor/20190408MarcFehling +++ /dev/null @@ -1,5 +0,0 @@ -New: Member function hp::FECollection::find_common_fes() -returns a set of indices from the full FECollection whose associated -finite elements dominate all elements of a given set of indices. -
-(Marc Fehling, 2019/04/08) diff --git a/doc/news/changes/minor/20190408MarcFehling-1 b/doc/news/changes/minor/20190408MarcFehling-1 deleted file mode 100644 index d3d4d9079c..0000000000 --- a/doc/news/changes/minor/20190408MarcFehling-1 +++ /dev/null @@ -1,5 +0,0 @@ -New: Member function hp::FECollection::find_enclosing_fes() -returns a set of indices from the full FECollection whose associated -finite elements are dominated by all elements of a given set of indices. -
-(Marc Fehling, 2019/04/08) diff --git a/doc/news/changes/minor/20190408MarcFehling-2 b/doc/news/changes/minor/20190408MarcFehling-2 deleted file mode 100644 index ea09694d85..0000000000 --- a/doc/news/changes/minor/20190408MarcFehling-2 +++ /dev/null @@ -1,5 +0,0 @@ -New: Member function hp::FECollection::find_dominating_fe() -returns the index of the most dominating finite element out of a given -set of indices. -
-(Marc Fehling, 2019/04/08) diff --git a/doc/news/changes/minor/20190408MarcFehling-3 b/doc/news/changes/minor/20190408MarcFehling-3 deleted file mode 100644 index d146817538..0000000000 --- a/doc/news/changes/minor/20190408MarcFehling-3 +++ /dev/null @@ -1,5 +0,0 @@ -New: Member function hp::FECollection::find_dominated_fe() -returns the index of the least dominating finite element out of a given -set of indices. -
-(Marc Fehling, 2019/04/08) diff --git a/doc/news/changes/minor/20190408MarcFehling-4 b/doc/news/changes/minor/20190408MarcFehling-4 deleted file mode 100644 index 1fb23b45cb..0000000000 --- a/doc/news/changes/minor/20190408MarcFehling-4 +++ /dev/null @@ -1,6 +0,0 @@ -New: Member function hp::FECollection::find_dominating_fe_extended() -returns the index of the most dominating finite element out of a given -set of indices. If none was found, the search will be extended on the -complete collection. -
-(Marc Fehling, 2019/04/08) diff --git a/doc/news/changes/minor/20190408MarcFehling-5 b/doc/news/changes/minor/20190408MarcFehling-5 deleted file mode 100644 index d21d050dd2..0000000000 --- a/doc/news/changes/minor/20190408MarcFehling-5 +++ /dev/null @@ -1,6 +0,0 @@ -New: Member function hp::FECollection::find_dominated_fe_extended() -returns the index of the least dominating finite element out of a given -set of indices. If none was found, the search will be extended on the -complete collection. -
-(Marc Fehling, 2019/04/08) diff --git a/doc/news/changes/minor/20190411LucaHeltai b/doc/news/changes/minor/20190411LucaHeltai deleted file mode 100644 index ad5ad6c437..0000000000 --- a/doc/news/changes/minor/20190411LucaHeltai +++ /dev/null @@ -1,4 +0,0 @@ -New: The method Mapping::get_center() allows one to retrieve the cell center of a cell when the -mapping object does not preserve vertex locations. -
-(Luca Heltai, 2019/04/11) diff --git a/doc/news/changes/minor/20190411LucaHeltai-b b/doc/news/changes/minor/20190411LucaHeltai-b deleted file mode 100644 index 70e5583207..0000000000 --- a/doc/news/changes/minor/20190411LucaHeltai-b +++ /dev/null @@ -1,3 +0,0 @@ -New: Added BoundingBox::extend() that allows extending and shrinking of BoundingBox objects. -
-(Luca Heltai, 2019/04/11) diff --git a/doc/news/changes/minor/20190411LucaHeltai-c b/doc/news/changes/minor/20190411LucaHeltai-c deleted file mode 100644 index e8a86eb0ff..0000000000 --- a/doc/news/changes/minor/20190411LucaHeltai-c +++ /dev/null @@ -1,3 +0,0 @@ -Fixed: Make sure that GridTools::Cache::get_cell_bounding_boxes_rtree() honors mappings. -
-(Luca Heltai, 2019/04/11) diff --git a/doc/news/changes/minor/20190412LucaHeltai b/doc/news/changes/minor/20190412LucaHeltai deleted file mode 100644 index b2e28e48dc..0000000000 --- a/doc/news/changes/minor/20190412LucaHeltai +++ /dev/null @@ -1,4 +0,0 @@ -New: The new FunctionFromFunctionObjects class allows one to wrap a vector of -std::function objects into a Function object, to allow fast prototyping of user codes. -
-(Luca Heltai, 2019/04/12) diff --git a/doc/news/changes/minor/20190418LucaHeltai b/doc/news/changes/minor/20190418LucaHeltai deleted file mode 100644 index a0b5e6a83b..0000000000 --- a/doc/news/changes/minor/20190418LucaHeltai +++ /dev/null @@ -1,3 +0,0 @@ -New: Functions::CutOffFunctionBase now supports rescaling the function to keep its integral equal to one. -
-(Luca Heltai, 2019/04/18) diff --git a/doc/news/changes/minor/20190422Jean-PaulPelteret b/doc/news/changes/minor/20190422Jean-PaulPelteret deleted file mode 100644 index 228beb10fa..0000000000 --- a/doc/news/changes/minor/20190422Jean-PaulPelteret +++ /dev/null @@ -1,5 +0,0 @@ -New: Some utility functions that facilitate the creation of both scalar and -tensor symbolic variables and symbolic functions have been added to the -Differentiation::SD namespace. -
-(Jean-Paul Pelteret, 2019/04/22) diff --git a/doc/news/changes/minor/20190423BrunoTurcksin b/doc/news/changes/minor/20190423BrunoTurcksin deleted file mode 100644 index 3a3c21db18..0000000000 --- a/doc/news/changes/minor/20190423BrunoTurcksin +++ /dev/null @@ -1,4 +0,0 @@ -Changed: The chunk_size used in CUDA kernels has been reduced from 8 to 1 to -improve performance on newer architectures. -
-(Bruno Turcksin, 2019/04/23) diff --git a/doc/news/changes/minor/20190423Jean-PaulPelteret b/doc/news/changes/minor/20190423Jean-PaulPelteret deleted file mode 100644 index 5558b79d1e..0000000000 --- a/doc/news/changes/minor/20190423Jean-PaulPelteret +++ /dev/null @@ -1,5 +0,0 @@ -New: Some utility functions that perform symbolic differentiation of scalar -symbolic expressions, as well as tensorial expressions, have been added to the -Differentiation::SD namespace. -
-(Jean-Paul Pelteret, 2019/04/23) diff --git a/doc/news/changes/minor/20190502Jean-PaulPelteret-1 b/doc/news/changes/minor/20190502Jean-PaulPelteret-1 deleted file mode 100644 index 8f41a0d8aa..0000000000 --- a/doc/news/changes/minor/20190502Jean-PaulPelteret-1 +++ /dev/null @@ -1,5 +0,0 @@ -Improved: The Workstream::run() function is now capable of working with iterator -ranges, or any general iterable object that defines the `begin()` and `end()` -of a range of elements to iterate over. -
-(Jean-Paul Pelteret, 2019/05/02) diff --git a/doc/news/changes/minor/20190502Jean-PaulPelteret-2 b/doc/news/changes/minor/20190502Jean-PaulPelteret-2 deleted file mode 100644 index ae68edd751..0000000000 --- a/doc/news/changes/minor/20190502Jean-PaulPelteret-2 +++ /dev/null @@ -1,5 +0,0 @@ -Improved: The `Meshworker::mesh_loop()` function is now capable of working with an -IteratorRange, and also supports iterator ranges constructed from -FilteredIterators. -
-(Jean-Paul Pelteret, 2019/05/02) diff --git a/doc/news/changes/minor/20190503LucaHeltai b/doc/news/changes/minor/20190503LucaHeltai deleted file mode 100644 index 1590818e35..0000000000 --- a/doc/news/changes/minor/20190503LucaHeltai +++ /dev/null @@ -1,4 +0,0 @@ -New: Mapping::get_bounding_box() returns the correct bounding box for mappings that do not preserve vertex -locations. -
-(Luca Heltai, 2019/05/03) diff --git a/doc/news/changes/minor/20190505Jean-PaulPelteret b/doc/news/changes/minor/20190505Jean-PaulPelteret deleted file mode 100644 index d1b38a8a28..0000000000 --- a/doc/news/changes/minor/20190505Jean-PaulPelteret +++ /dev/null @@ -1,4 +0,0 @@ -New: Some utility functions that facilitate the creation of symbolic maps and -symbolic substitution maps have been added to the Differentiation::SD namespace. -
-(Jean-Paul Pelteret, 2019/05/05) diff --git a/doc/news/changes/minor/20190505Jean-PaulPelteret-1 b/doc/news/changes/minor/20190505Jean-PaulPelteret-1 deleted file mode 100644 index 740787f95f..0000000000 --- a/doc/news/changes/minor/20190505Jean-PaulPelteret-1 +++ /dev/null @@ -1,4 +0,0 @@ -New: Some utility functions that resolve explicit (and cyclic) dependencies -between entries in symbolic substitution maps. -
-(Jean-Paul Pelteret, 2019/05/05) diff --git a/doc/news/changes/minor/20190507DenisDavydov b/doc/news/changes/minor/20190507DenisDavydov deleted file mode 100644 index d8db74fe31..0000000000 --- a/doc/news/changes/minor/20190507DenisDavydov +++ /dev/null @@ -1,3 +0,0 @@ -Improved: Extend Utilities::inverse_Hilbert_space_filling_curve to handle degenerate cases. -
-(Denis Davydov, 2019/05/07) diff --git a/doc/news/changes/minor/20190507Jean-PaulPelteret b/doc/news/changes/minor/20190507Jean-PaulPelteret deleted file mode 100644 index 542411c9d5..0000000000 --- a/doc/news/changes/minor/20190507Jean-PaulPelteret +++ /dev/null @@ -1,5 +0,0 @@ -New: Some utility functions that perform symbolic substitution on, and -evaluation of, symbolic scalar and tensor expressions have been added to the -Differentiation::SD namespace. -
-(Jean-Paul Pelteret, 2019/05/07) diff --git a/doc/news/changes/minor/20190508DenisDavydov b/doc/news/changes/minor/20190508DenisDavydov deleted file mode 100644 index db06a72b54..0000000000 --- a/doc/news/changes/minor/20190508DenisDavydov +++ /dev/null @@ -1,3 +0,0 @@ -New: Add DynamicSparsityPattern::get_view() to create a subset of a sparsity pattern based on a selection of some rows. -
-(Denis Davydov, 2019/05/08) diff --git a/doc/news/changes/minor/20190509DenisDavydov b/doc/news/changes/minor/20190509DenisDavydov deleted file mode 100644 index 3ff2b2ceb6..0000000000 --- a/doc/news/changes/minor/20190509DenisDavydov +++ /dev/null @@ -1,3 +0,0 @@ -New: Add Utilities::MPI::mean_and_standard_deviation() to calculate mean and standard deviation. -
-(Denis Davydov, 2019/05/09) diff --git a/doc/news/changes/minor/20190510MarcFehling b/doc/news/changes/minor/20190510MarcFehling deleted file mode 100644 index 02c397823f..0000000000 --- a/doc/news/changes/minor/20190510MarcFehling +++ /dev/null @@ -1,7 +0,0 @@ -New: Introduced indices for future finite elements that cells will be assigned -to after the triangulation changes. The future_fe_index of each cell can be -accessed and changed via member functions of the DoFCellAccessor class, -namely DoFCellAccessor::future_fe_index(), DoFCellAccessor::set_future_fe_index(), -DoFCellAccessor::future_fe_index_set(), and DoFCellAccessor::clear_future_fe_index(). -
-(Marc Fehling, 2019/05/10) diff --git a/doc/news/changes/minor/20190510MartinKronbichler b/doc/news/changes/minor/20190510MartinKronbichler deleted file mode 100644 index c837f84abb..0000000000 --- a/doc/news/changes/minor/20190510MartinKronbichler +++ /dev/null @@ -1,8 +0,0 @@ -Improved: DoFHandler::renumber_dofs() on parallel::distributed::Triangulation -would scale linearly with the number of MPI ranks on more than 50k ranks, -reaching times of more than 10 seconds on 150k ranks. This is now fixed for -the case the renumbering does not lead to a change in the underlying IndexSet -field of locally owned unknowns, i.e., in case the numbers merely change -within each MPI rank but not across them. -
-(Martin Kronbichler, 2019/05/10)