From 35e056a9c3a90932c9f8d76345178a6be5a2c2cc Mon Sep 17 00:00:00 2001 From: Timo Heister Date: Thu, 16 May 2019 11:05:42 -0600 Subject: [PATCH] fix doxygen @name tags --- include/deal.II/base/point.h | 4 ++-- include/deal.II/dofs/dof_tools.h | 6 ++++-- include/deal.II/fe/fe_values.h | 10 ++++++---- include/deal.II/grid/grid_generator.h | 5 +++-- include/deal.II/grid/grid_tools.h | 6 ++++-- include/deal.II/grid/tria_iterator.h | 16 ++++++++++++---- include/deal.II/lac/sparsity_pattern.h | 12 ++++++++---- include/deal.II/lac/tridiagonal_matrix.h | 2 +- include/deal.II/lac/trilinos_sparsity_pattern.h | 2 +- include/deal.II/matrix_free/matrix_free.h | 5 +++-- 10 files changed, 44 insertions(+), 24 deletions(-) diff --git a/include/deal.II/base/point.h b/include/deal.II/base/point.h index 5faa103340..11291018b5 100644 --- a/include/deal.II/base/point.h +++ b/include/deal.II/base/point.h @@ -176,7 +176,7 @@ public: Number & operator()(const unsigned int index); - /* + /** * @name Addition and subtraction of points. * @{ */ @@ -216,7 +216,7 @@ public: * @} */ - /* + /** * @name Multiplication and scaling of points. Dot products. Norms. * @{ */ diff --git a/include/deal.II/dofs/dof_tools.h b/include/deal.II/dofs/dof_tools.h index e41edb9f63..ebf85ee84c 100644 --- a/include/deal.II/dofs/dof_tools.h +++ b/include/deal.II/dofs/dof_tools.h @@ -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. * @{ */ /** diff --git a/include/deal.II/fe/fe_values.h b/include/deal.II/fe/fe_values.h index 040ef182ad..e93b0efbab 100644 --- a/include/deal.II/fe/fe_values.h +++ b/include/deal.II/fe/fe_values.h @@ -2138,8 +2138,9 @@ public: virtual ~FEValuesBase() override; - /// @name ShapeAccess Access to shape function values. These fields are filled - /// by the finite element. + /// @name ShapeAccess Access to shape function values + /// + /// These fields are filled by the finite element. //@{ /** @@ -2588,8 +2589,9 @@ public: 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 //@{ /** diff --git a/include/deal.II/grid/grid_generator.h b/include/deal.II/grid/grid_generator.h index 954168ded7..a3210b3a69 100644 --- a/include/deal.II/grid/grid_generator.h +++ b/include/deal.II/grid/grid_generator.h @@ -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. */ ///@{ diff --git a/include/deal.II/grid/grid_tools.h b/include/deal.II/grid/grid_tools.h index 4a3473f57c..38d40ff9af 100644 --- a/include/deal.II/grid/grid_tools.h +++ b/include/deal.II/grid/grid_tools.h @@ -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. */ /*@{*/ diff --git a/include/deal.II/grid/tria_iterator.h b/include/deal.II/grid/tria_iterator.h index a3ff0d7384..a37be90aa6 100644 --- a/include/deal.II/grid/tria_iterator.h +++ b/include/deal.II/grid/tria_iterator.h @@ -420,7 +420,9 @@ public: bool operator>(const TriaRawIterator &) const; - /**@name Advancement of iterators*/ + /** + * @name Advancement of iterators + */ /*@{*/ /** * Prefix ++ operator: ++iterator. This operator advances @@ -496,7 +498,9 @@ public: using pointer = Accessor *; using reference = Accessor &; - /**@name Exceptions*/ + /** + * @name Exceptions + */ /*@{*/ /** * Exception for TriaObjects with level, i.e. cells. @@ -684,7 +688,9 @@ public: TriaIterator & operator=(const TriaRawIterator &); - /**@name Advancement of iterators*/ + /** + * @name Advancement of iterators + */ /*@{*/ /** * Prefix ++ operator: ++i. This operator advances the @@ -891,7 +897,9 @@ public: TriaActiveIterator & operator++(); - /**@name Advancement of iterators*/ + /** + * @name Advancement of iterators + */ /*@{*/ /** * Postfix ++ operator: i++. This operator advances the diff --git a/include/deal.II/lac/sparsity_pattern.h b/include/deal.II/lac/sparsity_pattern.h index 5af5873890..b3ddd84ee3 100644 --- a/include/deal.II/lac/sparsity_pattern.h +++ b/include/deal.II/lac/sparsity_pattern.h @@ -368,8 +368,10 @@ public: 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. */ // @{ /** @@ -885,8 +887,10 @@ public: 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. */ // @{ /** diff --git a/include/deal.II/lac/tridiagonal_matrix.h b/include/deal.II/lac/tridiagonal_matrix.h index 9ccff0c068..5b92a38ecf 100644 --- a/include/deal.II/lac/tridiagonal_matrix.h +++ b/include/deal.II/lac/tridiagonal_matrix.h @@ -60,7 +60,7 @@ public: using size_type = types::global_dof_index; /** - * @name Constructors and initialization. + * @name Constructors and initialization */ /** * Constructor generating an empty matrix of dimension n. diff --git a/include/deal.II/lac/trilinos_sparsity_pattern.h b/include/deal.II/lac/trilinos_sparsity_pattern.h index d0a9859410..820af53d43 100644 --- a/include/deal.II/lac/trilinos_sparsity_pattern.h +++ b/include/deal.II/lac/trilinos_sparsity_pattern.h @@ -286,7 +286,7 @@ namespace TrilinosWrappers using const_iterator = SparsityPatternIterators::Iterator; /** - * @name Basic constructors and initialization. + * @name Basic constructors and initialization */ //@{ /** diff --git a/include/deal.II/matrix_free/matrix_free.h b/include/deal.II/matrix_free/matrix_free.h index a2dd169c71..1216bcf231 100644 --- a/include/deal.II/matrix_free/matrix_free.h +++ b/include/deal.II/matrix_free/matrix_free.h @@ -1464,8 +1464,9 @@ public: //@} /** - * @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. */ //@{ /** -- 2.39.5