DeclException0 (ExcMatrixDoesNotMatch);
/**
* A function has been called for a cell which should be
- * @ref GlossActive "active" , but is refined.
+ * @ref GlossActive "active", but is refined.
*
* @ingroup Exceptions
*/
DeclException0 (ExcMatrixDoesNotMatch);
/**
* A function has been called for a cell which should be
- * @ref GlossActive "active" , but is refined.
+ * @ref GlossActive "active", but is refined.
*
* @ingroup Exceptions
*/
* interpolation matrix with size no_face_dofs $\times$ no_face_dofs.
*
* Detailed information can be found in the see
- * @ref GlossPeriodicConstraints "Glossary entry on periodic boundary
- * conditions".
+ * @ref GlossPeriodicConstraints "Glossary entry on periodic boundary conditions".
*
* @todo: Reference to soon be written example step and glossary article.
*
* before.
*
* @see
- * @ref GlossPeriodicConstraints "Glossary entry on periodic boundary
- * conditions" for further information.
+ * @ref GlossPeriodicConstraints "Glossary entry on periodic boundary conditions" for further information.
*
* @author Daniel Arndt, Matthias Maier, 2013, 2014
*/
* need more functionality use GridTools::collect_periodic_faces() directly.
*
* @see
- * @ref GlossPeriodicConstraints "Glossary entry on periodic boundary
- * conditions" for further information.
+ * @ref GlossPeriodicConstraints "Glossary entry on periodic boundary conditions" for further information.
*
* @author Matthias Maier, 2012
*/
* need more functionality use GridTools::collect_periodic_faces() directly.
*
* @see
- * @ref GlossPeriodicConstraints "Glossary entry on periodic boundary
- * conditions" for further information.
+ * @ref GlossPeriodicConstraints "Glossary entry on periodic boundary conditions" for further information.
*/
template<typename DH>
void
* or several
* @ref GlossComponent "components" of the vector valued function. If the
* element is
- * @ref GlossPrimitive "primitive" , there is indeed a single component with a
+ * @ref GlossPrimitive "primitive", there is indeed a single component with a
* nonzero entry for each shape function. This component can be determined by
* system_to_component_index(), the number of components is
* FiniteElementData::n_components().
* Return a support point vector for generalized interpolation.
*
* See the
- * @ref GlossGeneralizedSupport "glossary entry on generalized support
- * points" for more information.
+ * @ref GlossGeneralizedSupport "glossary entry on generalized points" for more information.
*/
const std::vector<Point<dim> > &
get_generalized_support_points () const;
* get_unit_support_points() or get_generalized_support_points().
*
* See the
- * @ref GlossGeneralizedSupport "glossary entry on generalized support
- * points" for more information.
+ * @ref GlossGeneralizedSupport "glossary entry on generalized support points" for more information.
*/
bool has_generalized_support_points () const;
* and #interior_weights). Called from the constructor.
*
* See the
- * @ref GlossGeneralizedSupport "glossary entry on generalized support
- * points" for more information.
+ * @ref GlossGeneralizedSupport "glossary entry on generalized support points" for more information.
*/
void initialize_support_points (const unsigned int rt_degree);
* Initialize the FiniteElement<dim>::generalized_support_points and
* FiniteElement<dim>::generalized_face_support_points fields. Called from
* the constructor. See the
- * @ref GlossGeneralizedSupport "glossary entry on generalized support
- * points" for more information.
+ * @ref GlossGeneralizedSupport "glossary entry on generalized support points" for more information.
*/
void initialize_support_points (const unsigned int rt_degree);
/**
* constructor.
*
* See the
- * @ref GlossGeneralizedSupport "glossary entry on generalized support
- * points" for more information.
+ * @ref GlossGeneralizedSupport "glossary entry on generalized support points" for more information.
*/
void initialize_support_points (const unsigned int degree);
* #generalized_face_support_points when computing the integration.
*
* See the
- * @ref GlossGeneralizedSupport "glossary entry on generalized support
- * points" for more information.
+ * @ref GlossGeneralizedSupport "glossary entry on generalized support points" for more information.
*/
Table<2, double> boundary_weights;
* point and one column for each degree of freedom on the face.
*
* See the
- * @ref GlossGeneralizedSupport "glossary entry on generalized support
- * points" for more information.
+ * @ref GlossGeneralizedSupport "glossary entry on generalized support points" for more information.
*/
Table<2, double> boundary_weights;
/**
* the constructor.
*
* See the
- * @ref GlossGeneralizedSupport "glossary entry on generalized support
- * points" for more information.
+ * @ref GlossGeneralizedSupport "glossary entry on generalized support points" for more information.
*/
void initialize_support_points (const unsigned int rt_degree);
};
* interpreted as an interpolation matrix with size no_face_dofs $\times$
* no_face_dofs. For more details see make_periodicity_constraints() and
* the glossary
- * @ref GlossPeriodicConstraints "glossary entry on periodic boundary
- * conditions".
+ * @ref GlossPeriodicConstraints "glossary entry on periodic conditions".
*/
FullMatrix<double> matrix;
* matrix is interpreted as a rotation matrix that is applied to all vector
* valued blocks listed in @p first_vector_components of the FESystem. For
* more details see make_periodicity_constraints() and the glossary
- * @ref GlossPeriodicConstraints "glossary entry on periodic boundary
- * conditions".
+ * @ref GlossPeriodicConstraints "glossary entry on periodic conditions".
*
* @tparam Container A type that satisfies the requirements of a mesh
* container (see
* matrix is interpreted as a rotation matrix that is applied to all vector
* valued blocks listet in @p first_vector_components of the FESystem. For
* more details see make_periodicity_constraints() and the glossary
- * @ref GlossPeriodicConstraints "glossary entry on periodic boundary
- * conditions".
+ * @ref GlossPeriodicConstraints "glossary entry on periodic conditions".
*
* @tparam Container A type that satisfies the requirements of a mesh
* container (see
* Return a constant reference to the manifold object used for this object.
*
* As explained in
- * @ref boundary "Boundary and manifold description for triangulations" ,
+ * @ref boundary "Boundary and manifold description for triangulations",
* the process involved in finding the appropriate manifold description
* involves querying both the manifold or boundary indicators. See there for
* more information.
/**
* One bool per cell to indicate the direction of the normal true: use
* orientation from vertex false: revert the orientation. See
- * @ref GlossDirectionFlag .
+ * @ref GlossDirectionFlag.
*
* This is only used for codim==1 meshes.
*/
* @ref Sparsity.
*
* <b>Note:</b> There are several, exchangeable variations of this class, see
- * @ref Sparsity , section 'Dynamic block sparsity patterns' for more
+ * @ref Sparsity, section 'Dynamic block sparsity patterns' for more
* information.
*
* <b>Note:</b> This class used to be called CompressedBlockSparsityPattern.
* @ref Sparsity.
*
* @note There are several, exchangeable variations of this class, see
- * @ref Sparsity , section 'Dynamic block sparsity patterns' for more
+ * @ref Sparsity, section 'Dynamic block sparsity patterns' for more
* information.
*
* @author Wolfgang Bangerth, 2007
* @ref Sparsity.
*
* @note There are several, exchangeable variations of this class, see
- * @ref Sparsity , section 'Dynamic block sparsity patterns' for more
+ * @ref Sparsity, section 'Dynamic block sparsity patterns' for more
* information.
*
* This class is used in step-22 and step-31.
* <h3>Notes</h3>
*
* There are several, exchangeable variations of this class, see
- * @ref Sparsity , section '"Dynamic" or "compressed" sparsity patterns' for
+ * @ref Sparsity,
+ * section '"Dynamic" or "compressed" sparsity patterns' for
* more information.
*
* This class is a variation of the CompressedSparsityPattern class. Instead
* better than the CompressedSparsityPattern in the context of hp-adaptivity
* (see for example step-27), or generally when there are many nonzero entries
* in each row of a matrix (see
- * @ref step_22 "step-22"). On the other hand, a benchmark where nonzero
+ * @ref step_22 "step-22"). On the other hand, a benchmark where nonzero
* entries were randomly inserted into the sparsity pattern revealed that this
* class is slower by a factor 4-6 in this situation. Hence, currently the
* suggestion is to carefully analyze which of the CompressedSparsityPattern
* <h3>Notes</h3>
*
* There are several, exchangeable variations of this class, see
- * @ref Sparsity , section '"Dynamic" or "compressed" sparsity patterns' for
+ * @ref Sparsity,
+ * section '"Dynamic" or "compressed" sparsity patterns' for
* more information.
*
* @author Timo Heister, 2008
* <h3>Notes</h3>
*
* There are several, exchangeable variations of this class, see
- * @ref Sparsity , section '"Dynamic" or "compressed" sparsity patterns' for
+ * @ref Sparsity,
+ * section '"Dynamic" or "compressed" sparsity patterns' for
* more information.
*
* @author Wolfgang Bangerth, 2001
* elements per row (for example for vector-valued problems or hp finite
* elements). In this case, it is advisable to use the
* CompressedSetSparsityPattern class instead, see for example
- * @ref step_27 "step-27" , or to use the CompressedSimpleSparsityPattern
+ * @ref step_27 "step-27", or to use the CompressedSimpleSparsityPattern
* class, see for example
* @ref step_31 "step-31".
*/
* complement.
*
* @ingroup Matrix2
- * @ingroup vector_valued @see @ref GlossBlockLA "Block (linear algebra)"
+ * @ingroup vector_valued
+ *
+ * @see
+ * @ref GlossBlockLA "Block (linear algebra)"
* @author Guido Kanschat, 2006
*/
template <class MATRIX>
* the partitioning is changed again. This allows for efficient parallel
* communication of indices. In particular, it stores the communication
* pattern, rather than having to compute it again for every
- * communication. (For more information on ghost vectors, see also the
- * @ref GlossGhostedVector "glossary entry on vectors with ghost elements"
- * .) - Besides the usual global access operator () it is also possible to
+ * communication. For more information on ghost vectors, see also the
+ * @ref GlossGhostedVector "glossary entry on vectors with ghost elements".
+ * Besides the usual global access operator () it is also possible to
* access vector entries in the local index space with the function @p
* local_element(). Locally owned indices are placed first, [0,
* local_size()), and then all ghost indices follow after them
* assembly routine involving ghosts that fill this vector. Note that the
* @p insert mode of @p compress() does not set the elements included in
* ghost entries but simply discards them, assuming that the owning
- * processor has set them to the desired value already. (See also the
- * @ref GlossCompress "glossary entry on compress" .) - The
+ * processor has set them to the desired value already (See also the
+ * @ref GlossCompress "glossary entry on compress"). The
* <code>update_ghost_values()</code> function imports the data from the
* owning processor to the ghost indices in order to provide read access
* to the data associated with ghosts. - It is possible to split the above
* function, for much the same reason as is documented with the
* BlockSparsityPattern class.
*
- * @ingroup Matrix1 @see @ref GlossBlockLA "Block (linear algebra)"
+ * @ingroup Matrix1
+ * @see
+ * @ref GlossBlockLA "Block (linear algebra)"
* @author Wolfgang Bangerth, 2004
*/
class BlockSparseMatrix : public BlockMatrixBase<PETScWrappers::SparseMatrix>
* interface, this class handles the actual allocation of vectors and
* provides functions that are specific to the underlying vector type.
*
- * @ingroup Vectors @see @ref GlossBlockLA "Block (linear algebra)"
+ * @ingroup Vectors
+ *
+ * @see
+ * @ref GlossBlockLA "Block (linear algebra)"
* @author Wolfgang Bangerth, 2004
*/
class BlockVector : public BlockVectorBase<Vector>
* collect_sizes() function, for much the same reason as is documented
* with the BlockSparsityPattern class.
*
- * @ingroup Matrix1 @see @ref GlossBlockLA "Block (linear algebra)"
+ * @ingroup Matrix1
+ * @see
+ * @ref GlossBlockLA "Block (linear algebra)"
* @author Wolfgang Bangerth, 2004
*/
class BlockSparseMatrix : public BlockMatrixBase<SparseMatrix>
* as an example on how to do this.
*
* For further information and explanations on handling the
- * @ref SLEPcWrappers "SLEPcWrappers" , see also the
- * @ref PETScWrappers "PETScWrappers" , on which they depend.
+ * @ref SLEPcWrappers "SLEPcWrappers",
+ * see also the
+ * @ref PETScWrappers "PETScWrappers",
+ * on which they depend.
*
* @ingroup SLEPcWrappers
*
* function, for much the same reason as is documented with the
* BlockSparsityPattern class.
*
- * @ingroup Matrix1 @see @ref GlossBlockLA "Block (linear algebra)"
+ * @ingroup Matrix1
+ * @see
+ * @ref GlossBlockLA "Block (linear algebra)"
* @author Martin Kronbichler, Wolfgang Bangerth, 2008
*/
class BlockSparseMatrix : public BlockMatrixBase<SparseMatrix>
/**
* Return the first cell which we want output for. The default
* implementation returns the first
- * @ref GlossActive "active cell" , but you might want to return other cells
+ * @ref GlossActive "active cell", but you might want to return other cells
* in a derived class.
*/
virtual cell_iterator first_cell ();
* guaranteed as long as @p first_cell is also used from the default
* implementation. Overloading only one of the two functions might not be a
* good idea.
- */
+ */
virtual cell_iterator next_cell (const cell_iterator &cell);
/**