*
* @param p The point at which the function is to be evaluated.
* @param component The vector component. Since this function is scalar,
- * only zero is a valid argument here. @return The interpolated value at
+ * only zero is a valid argument here.
+ * @return The interpolated value at
* this point. If the point lies outside the set of coordinates, the
* function is extended by a constant.
*/
*
* @param p The point at which the function is to be evaluated.
* @param component The vector component. Since this function is scalar,
- * only zero is a valid argument here. @return The interpolated value at
+ * only zero is a valid argument here.
+ * @return The interpolated value at
* this point. If the point lies outside the set of coordinates, the
* function is extended by a constant.
*/
* in the documentation of active_cell_iterators().
*
* @param[in] level A given level in the refinement hierarchy of this
- * triangulation. @return The half open range <code>[this->begin(level),
+ * triangulation.
+ * @return The half open range <code>[this->begin(level),
* this->end(level))</code>
*
* @pre level must be less than this->n_levels().
* documentation of active_cell_iterators().
*
* @param[in] level A given level in the refinement hierarchy of this
- * triangulation. @return The half open range
+ * triangulation.
+ * @return The half open range
* <code>[this->begin_active(level), this->end(level))</code>
*
* @pre level must be less than this->n_levels().
* C++11. See the example in the documentation of active_cell_iterators().
*
* @param[in] level A given level in the refinement hierarchy of this
- * triangulation. @return The half open range <code>[this->begin_mg(level),
+ * triangulation.
+ * @return The half open range <code>[this->begin_mg(level),
* this->end_mg(level))</code>
*
* @pre level must be less than this->n_levels().
/**
* This class declares a local typedef that denotes a mapping between a
- * boundary indicator (see @ref GlossBoundaryIndicator) that is used to
+ * boundary indicator (see
+ * @ref GlossBoundaryIndicator
+ * ) that is used to
* describe what kind of boundary condition holds on a particular piece of the
* boundary, and the function describing the actual function that provides the
* boundary values on this part of the boundary. This type is required in many
* for more information.
*
* @param scalar An object that represents a single scalar vector component
- * of this finite element. @return A component mask that is false in all
+ * of this finite element.
+ * @return A component mask that is false in all
* components except for the one that corresponds to the argument.
*/
ComponentMask
* for more information.
*
* @param vector An object that represents dim vector components of this
- * finite element. @return A component mask that is false in all components
+ * finite element.
+ * @return A component mask that is false in all components
* except for the ones that corresponds to the argument.
*/
ComponentMask
*
* @param sym_tensor An object that represents dim*(dim+1)/2 components of
* this finite element that are jointly to be interpreted as forming a
- * symmetric tensor. @return A component mask that is false in all
+ * symmetric tensor.
+ * @return A component mask that is false in all
* components except for the ones that corresponds to the argument.
*/
ComponentMask
* ComponentMask.
*
* @param block_mask The mask that selects individual blocks of the finite
- * element @return A mask that selects those components corresponding to the
+ * element
+ * @return A mask that selects those components corresponding to the
* selected blocks of the input argument.
*/
ComponentMask
* exception.
*
* @param scalar An object that represents a single scalar vector component
- * of this finite element. @return A component mask that is false in all
+ * of this finite element.
+ * @return A component mask that is false in all
* components except for the one that corresponds to the argument.
*/
BlockMask
* full blocks and does not split blocks of this element.
*
* @param vector An object that represents dim vector components of this
- * finite element. @return A component mask that is false in all components
+ * finite element.
+ * @return A component mask that is false in all components
* except for the ones that corresponds to the argument.
*/
BlockMask
*
* @param sym_tensor An object that represents dim*(dim+1)/2 components of
* this finite element that are jointly to be interpreted as forming a
- * symmetric tensor. @return A component mask that is false in all
+ * symmetric tensor.
+ * @return A component mask that is false in all
* components except for the ones that corresponds to the argument.
*/
BlockMask
* exception.
*
* @param component_mask The mask that selects individual components of the
- * finite element @return A mask that selects those blocks corresponding to
+ * finite element
+ * @return A mask that selects those blocks corresponding to
* the selected blocks of the input argument.
*/
BlockMask
* @param mapping An optional argument used to denote the mapping that
* should be used when describing whether cells are bounded by straight or
* curved faces. The default is to use a $Q_1$ mapping, which corresponds to
- * straight lines bounding the cells. @return The dim-dimensional measure of
+ * straight lines bounding the cells.
+ * @return The dim-dimensional measure of
* the domain described by the triangulation, as discussed above.
*/
template <int dim, int spacedim>
* a mesh container (see
* @ref GlossMeshAsAContainer
* ).
- * @param p The point for which we want to find the closest vertex. @return
- * The index of the closest vertex found.
+ * @param p The point for which we want to find the closest vertex.
+ * @return The index of the closest vertex found.
*
* @author Ralf B. Schulz, 2006
*/
* @ref GlossMeshAsAContainer
* ).
* @param vertex_index The index of the vertex for which we try to find
- * adjacent cells. @return A vector of cells that lie adjacent to the given
+ * adjacent cells.
+ * @return A vector of cells that lie adjacent to the given
* vertex.
*
* @note If the point requested does not lie in any of the cells of the mesh
*
* @tparam Container A type that satisfies the requirements of a mesh
* container (see @ref GlossMeshAsAContainer).
- * @param cell An iterator pointing to a cell of the mesh container. @return
- * A list of active descendants of the given cell
+ * @param cell An iterator pointing to a cell of the mesh container.
+ * @return A list of active descendants of the given cell
*
* @note Since in C++ the type of the Container template argument can not be
* deduced from a function call, you will have to specify it after the
* returns.
*
* @param triangulation The triangulation of which the function evaluates
- * which vertices are locally owned. @return The subset of vertices, as
+ * which vertices are locally owned.
+ * @return The subset of vertices, as
* described above. The length of the returned array equals
* Triangulation.n_vertices() and may, consequently, be larger than
* Triangulation::n_used_vertices().
* in the documentation of active_cell_iterators().
*
* @param[in] level A given level in the refinement hierarchy of this
- * triangulation. @return The half open range <code>[this->begin(level),
+ * triangulation.
+ * @return The half open range <code>[this->begin(level),
* this->end(level))</code>
*
* @pre level must be less than this->n_levels().
* documentation of active_cell_iterators().
*
* @param[in] level A given level in the refinement hierarchy of this
- * triangulation. @return The half open range
+ * triangulation.
+ * @return The half open range
* <code>[this->begin_active(level), this->end(level))</code>
*
* @pre level must be less than this->n_levels().
* @param obj_index The number of the cell we are looking at.
* @param dofs_per_cell The number of DoFs per cell for this cell. This
* is not used for the hp case but necessary to keep the interface the
- * same as for the non-hp case. @return A pointer to the first DoF index
+ * same as for the non-hp case.
+ * @return A pointer to the first DoF index
* for the current cell. The next dofs_per_cell indices are for the
* current cell.
*/
* exception.
*
* @param scalar An object that represents a single scalar vector
- * component of this finite element. @return A component mask that is
+ * component of this finite element.
+ * @return A component mask that is
* false in all components except for the one that corresponds to the
* argument.
*/
* exception.
*
* @param vector An object that represents dim vector components of this
- * finite element. @return A component mask that is false in all
+ * finite element.
+ * @return A component mask that is false in all
* components except for the ones that corresponds to the argument.
*/
ComponentMask
*
* @param sym_tensor An object that represents dim*(dim+1)/2 components of
* this finite element that are jointly to be interpreted as forming a
- * symmetric tensor. @return A component mask that is false in all
+ * symmetric tensor.
+ * @return A component mask that is false in all
* components except for the ones that corresponds to the argument.
*/
ComponentMask
* exception.
*
* @param block_mask The mask that selects individual blocks of the finite
- * element @return A mask that selects those components corresponding to
+ * element
+ * @return A mask that selects those components corresponding to
* the selected blocks of the input argument.
*/
ComponentMask
* exception.
*
* @param scalar An object that represents a single scalar vector
- * component of this finite element. @return A component mask that is
+ * component of this finite element.
+ * @return A component mask that is
* false in all components except for the one that corresponds to the
* argument.
*/
* to full blocks and does not split blocks of this element.
*
* @param vector An object that represents dim vector components of this
- * finite element. @return A component mask that is false in all
+ * finite element.
+ * @return A component mask that is false in all
* components except for the ones that corresponds to the argument.
*/
BlockMask
*
* @param sym_tensor An object that represents dim*(dim+1)/2 components of
* this finite element that are jointly to be interpreted as forming a
- * symmetric tensor. @return A component mask that is false in all
+ * symmetric tensor.
+ * @return A component mask that is false in all
* components except for the ones that corresponds to the argument.
*/
BlockMask
* exception.
*
* @param component_mask The mask that selects individual components of
- * the finite element @return A mask that selects those blocks
+ * the finite element
+ * @return A mask that selects those blocks
* corresponding to the selected blocks of the input argument.
*/
BlockMask
* operations at the same time, for example by placing zero additions if
* necessary.
*
- * @see @ref GlossGhostedVector "vectors with ghost elements"
+ * @see
+ * @ref GlossGhostedVector "vectors with ghost elements"
*
* @ingroup PETScWrappers
* @ingroup Vectors
*
* @note This operation always creates a ghosted vector.
*
- * @see @ref GlossGhostedVector "vectors with ghost elements"
+ * @see
+ * @ref GlossGhostedVector "vectors with ghost elements"
*/
explicit Vector (const MPI_Comm &communicator,
const IndexSet &local,
*
* @note This operation always creates a ghosted vector.
*
- * @see @ref GlossGhostedVector "vectors with ghost elements"
+ * @see
+ * @ref GlossGhostedVector "vectors with ghost elements"
*/
Vector (const IndexSet &local,
const IndexSet &ghost,
* @deprecated Use Vector::reinit(const IndexSet &, const IndexSet &,
* const MPI_Comm &) instead.
*
- * @see @ref GlossGhostedVector "vectors with ghost elements"
+ * @see
+ * @ref GlossGhostedVector "vectors with ghost elements"
*/
void reinit (const MPI_Comm &communicator,
const IndexSet &local,
* Reinit as a vector without ghost elements. See the constructor with
* same signature for more details.
*
- * @see @ref GlossGhostedVector "vectors with ghost elements"
+ * @see
+ * @ref GlossGhostedVector "vectors with ghost elements"
*/
void reinit (const IndexSet &local,
const IndexSet &ghost,
* Reinit as a vector without ghost elements. See constructor with same
* signature for more details.
*
- * @see @ref GlossGhostedVector "vectors with ghost elements"
+ * @see
+ * @ref GlossGhostedVector "vectors with ghost elements"
*/
void reinit (const IndexSet &local,
const MPI_Comm &communicator);