Number &
operator()(const unsigned int index);
- /*
+ /**
* @name Addition and subtraction of points.
* @{
*/
* @}
*/
- /*
+ /**
* @name Multiplication and scaling of points. Dot products. Norms.
* @{
*/
*/
/**
- * @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.
* @{
*/
/**
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.
//@{
/**
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
//@{
/**
///@}
/**
- * @name Creating lower-dimensional meshes from parts of higher-dimensional
- * meshes
+ * @name Creating lower-dimensional meshes
+ *
+ * Created from parts of higher-dimensional meshes.
*/
///@{
/*@}*/
/**
- * @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.
*/
/*@{*/
bool
operator>(const TriaRawIterator &) const;
- /**@name Advancement of iterators*/
+ /**
+ * @name Advancement of iterators
+ */
/*@{*/
/**
* Prefix <tt>++</tt> operator: <tt>++iterator</tt>. This operator advances
using pointer = Accessor *;
using reference = Accessor &;
- /**@name Exceptions*/
+ /**
+ * @name Exceptions
+ */
/*@{*/
/**
* Exception for TriaObjects with level, i.e. cells.
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
TriaActiveIterator<Accessor> &
operator++();
- /**@name Advancement of iterators*/
+ /**
+ * @name Advancement of iterators
+ */
/*@{*/
/**
* Postfix <tt>++</tt> operator: <tt>i++</tt>. This operator advances the
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.
*/
// @{
/**
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.
*/
// @{
/**
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>.
using const_iterator = SparsityPatternIterators::Iterator;
/**
- * @name Basic constructors and initialization.
+ * @name Basic constructors and initialization
*/
//@{
/**
//@}
/**
- * @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.
*/
//@{
/**