/**
* Same as above but returning the sum, average, minimum, maximum,
* process id of minimum and maximum as a collective operation on the
- * given MPI @ref GlossMPICommunicator "communicator" @p mpi_communicator
- * for each entry of the vector.
+ * given MPI
+ * @ref GlossMPICommunicator "communicator"
+ * @p mpi_communicator for each entry of the vector.
*
* @note This function performs a single reduction sweep.
*
/**
* Same as above but returning the sum, average, minimum, maximum,
* process id of minimum and maximum as a collective operation on the
- * given MPI @ref GlossMPICommunicator "communicator" @p mpi_communicator
- * for each entry of the ArrayView.
+ * given MPI
+ * @ref GlossMPICommunicator "communicator"
+ * @p mpi_communicator for each entry of the ArrayView.
*
* @note This function performs a single reduction sweep.
*
/**
* The type used for coarse-cell ids. See the glossary
- * entry on @ref GlossCoarseCellId "coarse cell IDs" for more information.
+ * entry on
+ * @ref GlossCoarseCellId "coarse cell IDs"
+ * for more information.
*/
using coarse_cell_id = global_cell_index;
/**
* An invalid value for coarse cell ids. See the glossary
- * entry on @ref GlossCoarseCellId "coarse cell IDs" for more information.
+ * entry on
+ * @ref GlossCoarseCellId "coarse cell IDs"
+ * for more information.
*/
const types::coarse_cell_id invalid_coarse_cell_id =
static_cast<types::coarse_cell_id>(-1);
* @endcode
*
* All parallel triangulations share certain traits, such as the fact that
- * they communicate via @ref GlossMPICommunicator "MPI communicators" or
- * that they have
+ * they communicate via
+ * @ref GlossMPICommunicator "MPI communicators"
+ * or that they have
* @ref GlossLocallyOwnedCell "locally owned",
* @ref GlossGhostCell "ghost", and possibly
- * @ref GlossArtificialCell "artificial cells". This class provides
+ * @ref GlossArtificialCell "artificial cells".
+ * This class provides
* a number of member functions that allows querying some information
* about the triangulation that is independent of how exactly a
* parallel triangulation is implemented (i.e., which of the various
* every detail of a triangulation may be known on each processor.
* In particular, you have to expect that triangulations of classes
* derived from this one only store some of the active cells (namely,
- * the @ref GlossLocallyOwnedCell "locally owned cells"), along
- * with @ref GlossGhostCell "ghost cells" and possibly
- * @ref GlossArtificialCell "artificial cells". In contrast to the classes
+ * the
+ * @ref GlossLocallyOwnedCell "locally owned cells"),
+ * along with
+ * @ref GlossGhostCell "ghost cells"
+ * and possibly
+ * @ref GlossArtificialCell "artificial cells".
+ * In contrast to the classes
* derived from parallel::TriangulationBase, it is certain that the
* classes derived from the current class will not store the entire
* triangulation as long as it has a large enough number of cells. (The
* Constructor for the NedelecSZ element of given @p order. The maximal
* polynomial degree of the shape functions is `order+1` (in each variable;
* the total polynomial degree may be higher). If `order = 0`, the element is
- * linear and has degrees of freedom only on the edges. If `order >=1` the
+ * linear and has degrees of freedom only on the edges. If `order >= 1` the
* element has degrees of freedom on the edges, faces and volume. For example
* the 3D version of FE_NedelecSZ has 12 degrees of freedom for `order = 0`
* and 54 for `degree = 1`. It is important to have enough quadrature points
*
* This class stores the index of the coarse cell from which a cell is
* descendant (or, more specifically, the
- * entry on @ref GlossCoarseCellId "coarse cell IDs"),
+ * entry on
+ * @ref GlossCoarseCellId "coarse cell IDs"),
* together with information on how to reach the cell from that coarse cell
* (i.e., which child index to take on each level of the triangulation when
* moving from one cell to its children). The important point about this
/**
* Translate the unique id of a coarse cell to its index. See the glossary
- * entry on @ref GlossCoarseCellId "coarse cell IDs" for more information.
+ * entry on
+ * @ref GlossCoarseCellId "coarse cell IDs"
+ * for more information.
*
* @note For serial and shared triangulation both id and index are the same.
* For distributed triangulations setting both might differ, since the
/**
* Translate the index of coarse cell to its unique id. See the glossary
- * entry on @ref GlossCoarseCellId "coarse cell IDs" for more information.
+ * entry on
+ * @ref GlossCoarseCellId "coarse cell IDs"
+ * for more information.
*
* @note See the note of the method
* coarse_cell_id_to_coarse_cell_index().
/**
* List that for each locally-relevant coarse cell provides the
- * corresponding global @ref GlossCoarseCellId.
+ * corresponding global
+ * @ref GlossCoarseCellId.
*/
std::vector<types::coarse_cell_id> coarse_cell_index_to_coarse_cell_id;
* all siblings together how they will be coarsened. We distinguish between
* three different cases:
* <ol>
- * <li> Not all siblings flagged for coarsening: p-coarsening<br>
+ * <li> Not all siblings flagged for coarsening: p-coarsening.
+ * <br>
* We keep the @p future_fe_indices and clear the coarsen flags
* on all siblings.
* <li> All siblings flagged for coarsening, but not all for
- * p-adaptation: h-coarsening<br>
+ * p-adaptation: h-coarsening.
+ * <br>
* We keep the coarsen flags and clear all @p future_fe_indices
* on all siblings.
- * <li> All siblings flagged for coarsening and p-adaptation: p-coarsening<br>
+ * <li> All siblings flagged for coarsening and p-adaptation: p-coarsening.
+ * <br>
* We keep the @p future_fe_indices and clear the coarsen flags
* on all siblings.
* </ol>
/**
* Interpolate different finite element spaces. The interpolation of vector
- * @p data_1 (which is assumed to be ghosted, see @ref GlossGhostedVector)
+ * @p data_1 (which is assumed to be ghosted, see
+ * @ref GlossGhostedVector)
* is executed from the FE space represented by @p dof_1
* to the vector @p data_2 on FE space @p dof_2.
* The interpolation on each cell is represented by the matrix @p transfer.