Changed: clang-format replaces astyle as source code formatting tool.
<br>
-(2018/05/24, Matthias Maier, Daniel Arndt)
+(Matthias Maier, Daniel Arndt, 2018/05/24)
constraints (for example, complex-valued Dirichlet boundary conditions, or
periodic boundary conditions with an additional phase shift).
<br>
-(2018/05/31, Matthias Maier, Daniel Arndt, David Wells)
+(Matthias Maier, Daniel Arndt, David Wells, 2018/05/31)
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.
<br>
-(Graham Harper 07/09/2018)
+(Graham Harper, 07/09/2018)
Improved: GridGenerator::extrude_triangulation can now optionally extrude manifold
ids.
<br>
-(2018/08/11, David Wells)
+(David Wells, 2018/08/11)
Improved: The preconditioner and solver setup in step-20 has been rewritten
to highlight the new LinearOperator and PackagedOperation classes.
<br>
-(2019/02/08, Matthias Maier)
+(Matthias Maier, 2019/02/08)
overlapping communication and computation. The latter is inefficient as soon
as too many MPI requests are in flight.
<br>
-(Martin Kronbichler, Denis Davydov 2018/05/24)
+(Martin Kronbichler, Denis Davydov, 2018/05/24)
Improved: TimerOutput now dynamically adjust to the the width of Section column.
<br>
-(Denis Davydov 2018/05/29)
+(Denis Davydov, 2018/05/29)
New: TimerOutput::cpu_and_wall_times_grouped will print CPU and
wallclock time in a single table.
<br>
-(Denis Davydov 2018/05/29)
+(Denis Davydov, 2018/05/29)
Improved: Extend ScaLAPACKMatrix::invert() to use pXtrtri for inversion of triangular matrices.
<br>
-(Sambit Das 2018/06/06)
+(Sambit Das, 2018/06/06)
Fixed: CMake now supports again in-source builds (This functionality was
accidentally broken in the previous release).
<br>
-(Matthias Maier 2018/06/11)
+(Matthias Maier, 2018/06/11)
not set inside MatrixFree::cell_loop() for block vectors
with many blocks.
<br>
-(Denis Davydov 2018/06/12)
+(Denis Davydov, 2018/06/12)
Fixed: Mismatched numbers of components between the exact solution and
underlying FE in Step-51.
<br>
-(Pi-Yueh Chuang 2018/06/14)
+(Pi-Yueh Chuang, 2018/06/14)
and TrilinosWrapper::SparseMatrix::copy_from(other_matrix) for the case of
non-contiguous rows.
<br>
-(Uwe Koecher 2018/06/14)
+(Uwe Koecher, 2018/06/14)
the tuple to represent DataComponentInterpretation. The functions
were renamed to get_nonscalar_data_ranges().
<br>
-(Denis Davydov 2018/06/21)
+(Denis Davydov, 2018/06/21)
New: Add support for output of tensor-valued data in
DataOut::write_vtu().
-(Denis Davydov 2018/06/21)
+<br>
+(Denis Davydov, 2018/06/21)
New: Add GridGenerator::plate_with_a_hole() that generates a
rectangular plate with an (offset) cylindrical hole.
<br>
-(Denis Davydov 2018/06/21)
+(Denis Davydov, 2018/06/21)
New: Add FiniteSizeHistory class to store a finite-size history of objects.
<br>
-(Denis Davydov 2018/07/26)
+(Denis Davydov, 2018/07/26)
Fixed: Minor issues when using matrix-free cell categorization
with multi-grid operators.
<br>
-(Denis Davydov 2018/08/02)
+(Denis Davydov, 2018/08/02)
Fixed: Bug using ScaLAPACKMatrix::save() and load() for configurations with pHDF5 in combination with serial HDF5 matrices from user code.
<br>
-(Benjamin Brands 2018/08/10)
+(Benjamin Brands, 2018/08/10)
Fixed: MGConstrainedDofs::initialize(...) now handles refinement edges across periodic boundaries correctly.
<br>
-(Alexander Knieps 2018/08/13)
+(Alexander Knieps, 2018/08/13)
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.
+<br>
(Svenja Schoeder, 2018/08/21)
New: Add line minimization functions.
<br>
-(Denis Davydov 2018/09/13)
+(Denis Davydov, 2018/09/13)
New: extend Patterns::Tools::Convert to work with ComponentMask
and std::unique_ptr<FunctionParser>.
<br>
-(Denis Davydov 2018/09/19)
+(Denis Davydov, 2018/09/19)
New: Add optional flag to ParameterHandler to skip undefined
sections and parameters.
<br>
-(Denis Davydov 2018/09/20)
+(Denis Davydov, 2018/09/20)
New: Add inverse_Hilbert_space_filling_curve() to map points in dim-dimensional
space to line index of the Hilbert space filling curve.
<br>
-(Denis Davydov 2018/10/05)
+(Denis Davydov, 2018/10/05)
degrees of freedom. In the hp case, the active_fe_indices will be
initialized and communicated amongst all processors, additionally.
<br>
-(2019/02/10, Marc Fehling)
+(Marc Fehling, 2019/02/10)
temporary PreconditionIdentity(), or no argument as preconditioner argument
correctly.
<br>
-(Matthias Maier 2018/06/11)
+(Matthias Maier, 2019/02/13)