Skip to content

Commit

Permalink
Merge pull request #8202 from tjhei/fix_at_name_tags
Browse files Browse the repository at this point in the history
fix doxygen @name tags
  • Loading branch information
jppelteret committed May 16, 2019
2 parents a0db232 + 50c79d9 commit 6e6a2bf
Show file tree
Hide file tree
Showing 10 changed files with 44 additions and 24 deletions.
4 changes: 2 additions & 2 deletions include/deal.II/base/point.h
Original file line number Diff line number Diff line change
Expand Up @@ -176,7 +176,7 @@ class Point : public Tensor<1, dim, Number>
Number &
operator()(const unsigned int index);

/*
/**
* @name Addition and subtraction of points.
* @{
*/
Expand Down Expand Up @@ -216,7 +216,7 @@ class Point : public Tensor<1, dim, Number>
* @}
*/

/*
/**
* @name Multiplication and scaling of points. Dot products. Norms.
* @{
*/
Expand Down
6 changes: 4 additions & 2 deletions include/deal.II/dofs/dof_tools.h
Original file line number Diff line number Diff line change
Expand Up @@ -283,8 +283,10 @@ namespace DoFTools
*/

/**
* @name Functions to support code that generically uses both DoFHandler and
* hp::DoFHandler
* @name Generic Functions
*
* Functions to support code that generically uses both DoFHandler and
* hp::DoFHandler.
* @{
*/
/**
Expand Down
10 changes: 6 additions & 4 deletions include/deal.II/fe/fe_values.h
Original file line number Diff line number Diff line change
Expand Up @@ -2138,8 +2138,9 @@ class FEValuesBase : public Subscriptor
virtual ~FEValuesBase() override;


/// @name ShapeAccess Access to shape function values. These fields are filled
/// by the finite element.
/// @name Access to shape function values
///
/// These fields are filled by the finite element.
//@{

/**
Expand Down Expand Up @@ -2588,8 +2589,9 @@ class FEValuesBase : public Subscriptor
bool quadrature_points_fastest = false) const;

//@}
/// @name Access to second derivatives (Hessian matrices and Laplacians) of
/// global finite element fields
/// @name Access to second derivatives
///
/// Hessian matrices and Laplacians of global finite element fields
//@{

/**
Expand Down
5 changes: 3 additions & 2 deletions include/deal.II/grid/grid_generator.h
Original file line number Diff line number Diff line change
Expand Up @@ -1520,8 +1520,9 @@ namespace GridGenerator
///@}

/**
* @name Creating lower-dimensional meshes from parts of higher-dimensional
* meshes
* @name Creating lower-dimensional meshes
*
* Created from parts of higher-dimensional meshes.
*/
///@{

Expand Down
6 changes: 4 additions & 2 deletions include/deal.II/grid/grid_tools.h
Original file line number Diff line number Diff line change
Expand Up @@ -2147,8 +2147,10 @@ namespace GridTools

/*@}*/
/**
* @name Extracting and creating patches of cells surrounding a single cell,
* and creating triangulation out of them
* @name Extracting and creating patches of cells
*
* These functions extract and create patches of cells surrounding a single
* cell, and creating triangulation out of them.
*/
/*@{*/

Expand Down
16 changes: 12 additions & 4 deletions include/deal.II/grid/tria_iterator.h
Original file line number Diff line number Diff line change
Expand Up @@ -420,7 +420,9 @@ class TriaRawIterator
bool
operator>(const TriaRawIterator &) const;

/**@name Advancement of iterators*/
/**
* @name Advancement of iterators
*/
/*@{*/
/**
* Prefix <tt>++</tt> operator: <tt>++iterator</tt>. This operator advances
Expand Down Expand Up @@ -496,7 +498,9 @@ class TriaRawIterator
using pointer = Accessor *;
using reference = Accessor &;

/**@name Exceptions*/
/**
* @name Exceptions
*/
/*@{*/
/**
* Exception for TriaObjects with level, i.e. cells.
Expand Down Expand Up @@ -684,7 +688,9 @@ class TriaIterator : public TriaRawIterator<Accessor>
TriaIterator<Accessor> &
operator=(const TriaRawIterator<OtherAccessor> &);

/**@name Advancement of iterators*/
/**
* @name Advancement of iterators
*/
/*@{*/
/**
* Prefix <tt>++</tt> operator: <tt>++i</tt>. This operator advances the
Expand Down Expand Up @@ -891,7 +897,9 @@ class TriaActiveIterator : public TriaIterator<Accessor>
TriaActiveIterator<Accessor> &
operator++();

/**@name Advancement of iterators*/
/**
* @name Advancement of iterators
*/
/*@{*/
/**
* Postfix <tt>++</tt> operator: <tt>i++</tt>. This operator advances the
Expand Down
12 changes: 8 additions & 4 deletions include/deal.II/lac/sparsity_pattern.h
Original file line number Diff line number Diff line change
Expand Up @@ -368,8 +368,10 @@ class SparsityPatternBase : public Subscriptor
static const size_type invalid_entry = numbers::invalid_size_type;

/**
* @name Construction and setup Constructors, destructor; functions
* initializing, copying and filling an object.
* @name Construction and Initialization
*
* Constructors, destructor, functions initializing, copying and filling an
* object.
*/
// @{
/**
Expand Down Expand Up @@ -885,8 +887,10 @@ class SparsityPattern : public SparsityPatternBase
using SparsityPatternBase::reinit;

/**
* @name Construction and setup Constructors, destructor; functions
* initializing, copying and filling an object.
* @name Construction and setup
*
* Constructors, destructor, functions initializing, copying and filling an
* object.
*/
// @{
/**
Expand Down
2 changes: 1 addition & 1 deletion include/deal.II/lac/tridiagonal_matrix.h
Original file line number Diff line number Diff line change
Expand Up @@ -60,7 +60,7 @@ class TridiagonalMatrix
using size_type = types::global_dof_index;

/**
* @name Constructors and initialization.
* @name Constructors and initialization
*/
/**
* Constructor generating an empty matrix of dimension <tt>n</tt>.
Expand Down
2 changes: 1 addition & 1 deletion include/deal.II/lac/trilinos_sparsity_pattern.h
Original file line number Diff line number Diff line change
Expand Up @@ -286,7 +286,7 @@ namespace TrilinosWrappers
using const_iterator = SparsityPatternIterators::Iterator;

/**
* @name Basic constructors and initialization.
* @name Basic constructors and initialization
*/
//@{
/**
Expand Down
5 changes: 3 additions & 2 deletions include/deal.II/matrix_free/matrix_free.h
Original file line number Diff line number Diff line change
Expand Up @@ -1464,8 +1464,9 @@ class MatrixFree : public Subscriptor
//@}

/**
* @name 5: Access of internal data structure (expert mode, interface not
* stable between releases)
* @name 5: Access of internal data structure
*
* Note: Expert mode, interface not stable between releases.
*/
//@{
/**
Expand Down

0 comments on commit 6e6a2bf

Please sign in to comment.