Skip to content

Commit

Permalink
doxygen comments: @ref fixes
Browse files Browse the repository at this point in the history
A few more @ref fixes missed in dealii#13836
  • Loading branch information
tjhei committed May 29, 2022
1 parent 6e2c6c9 commit 00af8c5
Show file tree
Hide file tree
Showing 6 changed files with 53 additions and 23 deletions.
3 changes: 2 additions & 1 deletion include/deal.II/distributed/shared_tria.h
Original file line number Diff line number Diff line change
Expand Up @@ -500,7 +500,8 @@ namespace internal
*
* This class has effect only if artificial cells are allowed. Without
* artificial cells, the current subdomain IDs already correspond to the
* true subdomain IDs. See the @ref GlossArtificialCell "glossary"
* true subdomain IDs. See the
* @ref GlossArtificialCell "glossary"
* for more information about artificial cells.
*/
template <int dim, int spacedim = dim>
Expand Down
4 changes: 2 additions & 2 deletions include/deal.II/fe/fe_poly_tensor.h
Original file line number Diff line number Diff line change
Expand Up @@ -252,8 +252,8 @@ class FE_PolyTensor : public FiniteElement<dim, spacedim>
* The constructor of this class fills this table with 'false' values, i.e.,
* no sign change at all. Derived finite element classes have to
* fill this Table with the correct values, see the documentation in
* GeometryInfo<dim> and
* this @ref GlossFaceOrientation "glossary entry on face orientation".
* GeometryInfo<dim> and this
* @ref GlossFaceOrientation "glossary entry on face orientation".
*
* The table must be filled in finite element classes derived
* from FE_PolyTensor in a meaningful way since the permutation
Expand Down
3 changes: 2 additions & 1 deletion include/deal.II/fe/fe_raviart_thomas.h
Original file line number Diff line number Diff line change
Expand Up @@ -223,7 +223,8 @@ class FE_RaviartThomas : public FE_PolyTensor<dim>
* flipped (rotated by +180 degrees) or rotated (rotated by +90 degrees)
* faces. These are given in the form three flags (face_orientation,
* face_flip, face_rotation), see the documentation in GeometryInfo<dim> and
* this @ref GlossFaceOrientation "glossary entry on face orientation".
* this
* @ref GlossFaceOrientation "glossary entry on face orientation".
*
* <h3>Example: Raviart-Thomas Elements of order 2 (tensor polynomial
* degree 3)</h3>
Expand Down
3 changes: 2 additions & 1 deletion include/deal.II/grid/grid_reordering.h
Original file line number Diff line number Diff line change
Expand Up @@ -27,7 +27,8 @@ DEAL_II_NAMESPACE_OPEN

/**
* A class implementing various grid reordering algorithms. For more information
* see the @ref reordering "reordering module".
* see the
* @ref reordering "reordering module".
*
* @deprecated Use GridTools::invert_all_negative_measure_cells() or
* GridTools::consistently_order_cells() instead of the functions provided by
Expand Down
28 changes: 20 additions & 8 deletions include/deal.II/particles/particle.h
Original file line number Diff line number Diff line change
Expand Up @@ -229,8 +229,11 @@ namespace Particles
* on both the locally owned cells, as well as on ghost cells. The
* particles on the latter are *copies* of particles owned on other
* processors, and should therefore be treated in the same way as
* ghost entries in @ref GlossGhostedVector "vectors with ghost elements"
* or @ref GlossGhostCell "ghost cells": In both cases, one should
* ghost entries in
* @ref GlossGhostedVector "vectors with ghost elements"
* or
* @ref GlossGhostCell "ghost cells":
* In both cases, one should
* treat the ghost elements or cells as `const` objects that shouldn't
* be modified even if the objects allow for calls that modify
* properties. Rather, properties should only be modified on processors
Expand All @@ -257,8 +260,11 @@ namespace Particles
* on both the locally owned cells, as well as on ghost cells. The
* particles on the latter are *copies* of particles owned on other
* processors, and should therefore be treated in the same way as
* ghost entries in @ref GlossGhostedVector "vectors with ghost elements"
* or @ref GlossGhostCell "ghost cells": In both cases, one should
* ghost entries in
* @ref GlossGhostedVector "vectors with ghost elements"
* or
* @ref GlossGhostCell "ghost cells":
* In both cases, one should
* treat the ghost elements or cells as `const` objects that shouldn't
* be modified even if the objects allow for calls that modify
* properties. Rather, properties should only be modified on processors
Expand Down Expand Up @@ -302,8 +308,11 @@ namespace Particles
* on both the locally owned cells, as well as on ghost cells. The
* particles on the latter are *copies* of particles owned on other
* processors, and should therefore be treated in the same way as
* ghost entries in @ref GlossGhostedVector "vectors with ghost elements"
* or @ref GlossGhostCell "ghost cells": In both cases, one should
* ghost entries in
* @ref GlossGhostedVector "vectors with ghost elements"
* or
* @ref GlossGhostCell "ghost cells":
* In both cases, one should
* treat the ghost elements or cells as `const` objects that shouldn't
* be modified even if the objects allow for calls that modify
* properties. Rather, properties should only be modified on processors
Expand Down Expand Up @@ -344,8 +353,11 @@ namespace Particles
* on both the locally owned cells, as well as on ghost cells. The
* particles on the latter are *copies* of particles owned on other
* processors, and should therefore be treated in the same way as
* ghost entries in @ref GlossGhostedVector "vectors with ghost elements"
* or @ref GlossGhostCell "ghost cells": In both cases, one should
* ghost entries in
* @ref GlossGhostedVector "vectors with ghost elements"
* or
* @ref GlossGhostCell "ghost cells":
* In both cases, one should
* treat the ghost elements or cells as `const` objects that shouldn't
* be modified even if the objects allow for calls that modify
* properties. Rather, properties should only be modified on processors
Expand Down
35 changes: 25 additions & 10 deletions include/deal.II/particles/particle_accessor.h
Original file line number Diff line number Diff line change
Expand Up @@ -135,8 +135,11 @@ namespace Particles
* on both the locally owned cells, as well as on ghost cells. The
* particles on the latter are *copies* of particles owned on other
* processors, and should therefore be treated in the same way as
* ghost entries in @ref GlossGhostedVector "vectors with ghost elements"
* or @ref GlossGhostCell "ghost cells": In both cases, one should
* ghost entries in
* @ref GlossGhostedVector "vectors with ghost elements"
* or
* @ref GlossGhostCell "ghost cells":
* In both cases, one should
* treat the ghost elements or cells as `const` objects that shouldn't
* be modified even if the objects allow for calls that modify
* properties. Rather, properties should only be modified on processors
Expand All @@ -163,8 +166,11 @@ namespace Particles
* on both the locally owned cells, as well as on ghost cells. The
* particles on the latter are *copies* of particles owned on other
* processors, and should therefore be treated in the same way as
* ghost entries in @ref GlossGhostedVector "vectors with ghost elements"
* or @ref GlossGhostCell "ghost cells": In both cases, one should
* ghost entries in
* @ref GlossGhostedVector "vectors with ghost elements"
* or
* @ref GlossGhostCell "ghost cells":
* In both cases, one should
* treat the ghost elements or cells as `const` objects that shouldn't
* be modified even if the objects allow for calls that modify
* properties. Rather, properties should only be modified on processors
Expand Down Expand Up @@ -229,8 +235,11 @@ namespace Particles
* on both the locally owned cells, as well as on ghost cells. The
* particles on the latter are *copies* of particles owned on other
* processors, and should therefore be treated in the same way as
* ghost entries in @ref GlossGhostedVector "vectors with ghost elements"
* or @ref GlossGhostCell "ghost cells": In both cases, one should
* ghost entries in
* @ref GlossGhostedVector "vectors with ghost elements"
* or
* @ref GlossGhostCell "ghost cells":
* In both cases, one should
* treat the ghost elements or cells as `const` objects that shouldn't
* be modified even if the objects allow for calls that modify
* properties. Rather, properties should only be modified on processors
Expand All @@ -249,8 +258,11 @@ namespace Particles
* on both the locally owned cells, as well as on ghost cells. The
* particles on the latter are *copies* of particles owned on other
* processors, and should therefore be treated in the same way as
* ghost entries in @ref GlossGhostedVector "vectors with ghost elements"
* or @ref GlossGhostCell "ghost cells": In both cases, one should
* ghost entries in
* @ref GlossGhostedVector "vectors with ghost elements"
* or
* @ref GlossGhostCell "ghost cells":
* In both cases, one should
* treat the ghost elements or cells as `const` objects that shouldn't
* be modified even if the objects allow for calls that modify
* properties. Rather, properties should only be modified on processors
Expand All @@ -272,8 +284,11 @@ namespace Particles
* on both the locally owned cells, as well as on ghost cells. The
* particles on the latter are *copies* of particles owned on other
* processors, and should therefore be treated in the same way as
* ghost entries in @ref GlossGhostedVector "vectors with ghost elements"
* or @ref GlossGhostCell "ghost cells": In both cases, one should
* ghost entries in
* @ref GlossGhostedVector "vectors with ghost elements"
* or
* @ref GlossGhostCell "ghost cells":
* In both cases, one should
* treat the ghost elements or cells as `const` objects that shouldn't
* be modified even if the objects allow for calls that modify
* properties. Rather, properties should only be modified on processors
Expand Down

0 comments on commit 00af8c5

Please sign in to comment.