process_changed "tests include source examples cmake/scripts contrib/python-bindings" \
".*\.(cc|h|inst.in|output.*|cmake)" fix_permissions
+process_changed "doc/news/*/*" "*" fix_permissions
+
process_changed "tests include source examples cmake/scripts contrib/python-bindings" \
".*\.(cc|h|inst.in|cmake)" dos_to_unix
+process_changed "doc/news/*/*" "*" dos_to_unix
+
#
# Removing trailing whitespace
#
process_changed "tests include source examples cmake/scripts contrib/python-bindings doc" \
".*\.(cc|h|html|dox|txt)" remove_trailing_whitespace
+process_changed "doc/news/*/*" "*" remove_trailing_whitespace
+
#
# Ensure only a single newline at end of files
#
process_changed "tests include source examples cmake/scripts contrib/python-bindings doc" \
".*\.(cc|h|html|dox|txt)" ensure_single_trailing_newline
+
+process_changed "doc/news/*/*" "*" ensure_single_trailing_newline
process "tests include source examples cmake/scripts contrib/python-bindings" \
".*\.(cc|h|inst.in|output.*|cmake)" fix_permissions
+process "doc/news/*/*" "*" fix_permissions
+
process "tests include source examples cmake/scripts contrib/python-bindings" \
".*\.(cc|h|inst.in|cmake)" dos_to_unix
+process "doc/news/*/*" "*" dos_to_unix
+
#
# Removing trailing whitespace
#
process "tests include source examples cmake/scripts contrib/python-bindings doc" \
".*\.(cc|h|html|dox|txt)" remove_trailing_whitespace
+process "doc/news/*/*" "*" remove_trailing_whitespace
+
#
# Ensure only a single newline at end of files
#
process "tests include source examples cmake/scripts contrib/python-bindings doc" \
".*\.(cc|h|html|dox|txt)" ensure_single_trailing_newline
+
+process "doc/news/*/*" "*" ensure_single_trailing_newline
-Changed: When calling Triangulation::get_manifold(manifold_id) for
+Changed: When calling Triangulation::get_manifold(manifold_id) for
a non-existing manifold_id, the function returned a flat manifold.
This behaviour has been changed and an assert is thrown in this case.
Furthermore, the functions Triangulation::reset_manifold() and
Removed: The deprecated Functions::LevelSet namespace
has been removed
<br>
-(Daniel Arndt, 2023/06/30)
+(Daniel Arndt, 2023/06/30)
have been removed.
<br>
(Daniel Arndt, 2023/07/03)
-
Removed: The file `include/deal.II/multigrid/mg_constrained_dofs.h`
-used to include `deal.II/dofs/dof_tools.h` and
+used to include `deal.II/dofs/dof_tools.h` and
`deal.II/multigrid/mg_tools.h`. This is not the case any more.
<br>
(Peter Munch, 2023/10/31)
New: The new tutorial step-87 presents the advanced point evaluation
-functionalities of deal.II, specifically useful for evaluating
+functionalities of deal.II, specifically useful for evaluating
finite element solutions at arbitrary points on distributed meshes.
<br>
(Magdalena Schreter-Fleischhacker, Peter Munch, 2023/09/05)
-New: Added a function DoFTools::map_boundary_to_bulk_dof_iterators() that
+New: Added a function DoFTools::map_boundary_to_bulk_dof_iterators() that
generates a mapping of codimension-1 active DoFHandler cell iterators to
codimension-0 cells and face indices, to couple DoFHandler objects of different
co-dimensions, initialized on grids generated with
status lines and prints a summary after invocation.
<br>
(Matthias Maier, 2023/06/30)
-
-Improvement: Step-68 now uses the FEPointEvaluation to calculate the particle velocity from the velocity solution instead of manually interpolating at the particle location.
+Improvement: Step-68 now uses the FEPointEvaluation to calculate the particle velocity from the velocity solution instead of manually interpolating at the particle location.
<br>
(Bruno Blais, 2023/07/0)
-New: Similar to the DataOut::add_data_vector() case,
+New: Similar to the DataOut::add_data_vector() case,
DataOut::add_mg_data_vector() now also copies the vector
and performs the ghost-vector update internally.
<br>
-Improvement: Added gradient() implementation to VectorFunctionFromTensorFunction in
+Improvement: Added gradient() implementation to VectorFunctionFromTensorFunction in
function.h file.
<br>
(Abbas Ballout, 2023/07/30)
-Improved: GridTools::find_active_cell_around_point() and
+Improved: GridTools::find_active_cell_around_point() and
GridTools::find_all_active_cells_around_point() now also work
for simplices.
<br>
New: Add two tensor functions for the split of a 2nd-order symmetric tensor
into a positive part and a negative part based on the signs of the eigenvalues
obtained from the spectrum decomposition. The function positive_negative_split()
-performs the positive-negative split of the 2nd-order symmetric tensor given as
+performs the positive-negative split of the 2nd-order symmetric tensor given as
the input. The function positive_negative_projectors() not only performs the split,
-but also provides the derivatives (two fourth-order tensors) of the positive/negative
+but also provides the derivatives (two fourth-order tensors) of the positive/negative
part of the tensor with respect to the input tensor.
<br>
(Tao Jin, 2023/08/22)
-New: Added QGaussRadau quadrature up to and including 8 quadrature points.
+New: Added QGaussRadau quadrature up to and including 8 quadrature points.
<br>
-(Jan Philipp Thiele, 2023/09/15)
\ No newline at end of file
+(Jan Philipp Thiele, 2023/09/15)
-Changed: The interface to QGaussRadauChebyshev<dim>
+Changed: The interface to QGaussRadauChebyshev<dim>
now matches that of the new quadrature QGaussRadau<dim>.
<br>
(Jan Philipp Thiele, 2023/09/16)
-New: Add alternative interfaces to RemotePointEvaluation::evaluate_and_proecss and
+New: Add alternative interfaces to RemotePointEvaluation::evaluate_and_proecss and
RemotePointEvaluation::process_and_evaluate.
<br>
(Magdalena Schreter, Peter Munch, 2023/09/17)
-New: New constructor for IndexSet that takes a
-Teuchos::RCP<Tpetra::Map> as input. And the
-function IndexSet::make_tpetra_map_rcp()
+New: New constructor for IndexSet that takes a
+Teuchos::RCP<Tpetra::Map> as input. And the
+function IndexSet::make_tpetra_map_rcp()
returning a Teuchos::RCP<Tpetra::Map>.
<br>
(Sebastian Kinnewig, 2023/10/17)
Fixed: The periodic faces information was not being copied
when using the `Triangulation::copy_triangulation()` function. This is now fixed.
<br>
-(Laura Prieto Saavedra, Peter Munch, 2023/10/19)
\ No newline at end of file
+(Laura Prieto Saavedra, Peter Munch, 2023/10/19)
Improved: Point now supports constexpr construction and evaluation,
just like Tensor.
<br>
-(Chengjiang Yin, 2023/11/09)
\ No newline at end of file
+(Chengjiang Yin, 2023/11/09)
-Fixed: Exceptions of type RecoverableUserCallbackError, raised in
-callbacks `solve_with_jacobian` and
-`solve_with_jacobian_and_track_n_linear_iterations` of the
+Fixed: Exceptions of type RecoverableUserCallbackError, raised in
+callbacks `solve_with_jacobian` and
+`solve_with_jacobian_and_track_n_linear_iterations` of the
TrilinosWrappers::NOXSolver class, are now treated as "recoverable",
if the NOX parameter "Newton/Rescue Bad Newton Solve" is set to `true`,
-which is, in fact, its default value. Exceptions of all other types and
-also all exceptions raised in other callbacks are still treated as
+which is, in fact, its default value. Exceptions of all other types and
+also all exceptions raised in other callbacks are still treated as
"irrecoverable".
<br>
(Vladimir Ivannikov, 2023/12/26)