-New: add Point<dim,Number>::distance_square() which calculates the squared
+New: Add Point<dim,Number>::distance_square() which calculates the squared
Euclidean distance.
<br>
(Denis Davydov, 2017/04/24)
-New: add a new class ConsecutiveControl which returns SolverControl::State::success
+New: Add a new class ConsecutiveControl which returns SolverControl::State::success
if and only if a certain positive number of consecutive iterations satisfy the
specified tolerance.
<br>
-New: add Utilities::LinearAlgebra::Lanczos_largest_eigenvalue() to estimate the largest
+New: Add Utilities::LinearAlgebra::Lanczos_largest_eigenvalue() to estimate the largest
eigenvalue of a symmetric linear operator using k-steps of Lanczos algorithm.
<br>
(Denis Davydov, 2017/08/01)
-New: add Utilities::LinearAlgebra::Chebyshev_filter() to apply Chebyshev filter of a
+New: Add Utilities::LinearAlgebra::Chebyshev_filter() to apply Chebyshev filter of a
given degree.
<br>
(Denis Davydov, 2017/08/02)
-New: add MGTransferBlockMatrixFree which allows using geometric multi-grids with
+New: Add MGTransferBlockMatrixFree which allows using geometric multi-grids with
LinearAlgebra::distributed::BlockVector<Number> where each block uses the same
index space of degrees of freedom.
<br>
-New: extend Point::distance_square() to work with VectorizedArray numbers.
+New: Extend Point::distance_square() to work with VectorizedArray numbers.
<br>
(Denis Davydov, 2017/08/24)
-New: add Utilities::MPI::sum() for FullMatrix objects.
+New: Add Utilities::MPI::sum() for FullMatrix objects.
<br>
(Denis Davydov, 2017/09/04)
-Fixed: the hp version of DoFTools::make_flux_sparsity_pattern() with masks for
+Fixed: The hp version of DoFTools::make_flux_sparsity_pattern() with masks for
DoF couplings now works with non-primitive FE spaces, similarly to its non-hp version.
The hp version of VectorTools::project_boundary_values() is modified to work properly with Hdiv
conforming finite elements.
-New: extend MappingQEulerian to work with multi-grid vectors.
+New: Extend MappingQEulerian to work with multi-grid vectors.
<br>
(Denis Davydov, 2017/09/27)
-New: add MGTransferMatrixFree::interpolate_to_mg() to transfer fine-level
+New: Add MGTransferMatrixFree::interpolate_to_mg() to transfer fine-level
solution to a multi-grid vector
<br>
(Denis Davydov, 2017/09/27)
-New: add LinearAlgebra::distributed::BlockVector<Number>::multivector_inner_product()
+New: Add LinearAlgebra::distributed::BlockVector<Number>::multivector_inner_product()
to perform inner product between each block of the two block vectors.
<br>
(Denis Davydov, 2017/09/30)
-New: add Utilities::MPI::sum() for LAPACKFullMatrix objects.
+New: Add Utilities::MPI::sum() for LAPACKFullMatrix objects.
<br>
(Denis Davydov, 2017/09/04)
-New: add LAPACKFullMatrix::trace() to calculate trace of a matrix.
+New: Add LAPACKFullMatrix::trace() to calculate trace of a matrix.
<br>
(Denis Davydov, 2017/10/09)
-New: add LAPACKFullMatrix<number>::add (const number a, const LAPACKFullMatrix<number> &A)
+New: Add LAPACKFullMatrix<number>::add (const number a, const LAPACKFullMatrix<number> &A)
<br>
(Denis Davydov, 2017/10/25)
-New:Added Utilities::pack and Utilities::unpack, to serialize and unserialize arbitrary
+New: Add Utilities::pack and Utilities::unpack, to serialize and unserialize arbitrary
objects that support boost::serialization/deserialization.
<br>
(Luca Heltai, 2017/11/18)