]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Update documentation of FE_PolyTensor. 8618/head
authorWolfgang Bangerth <bangerth@colostate.edu>
Wed, 21 Aug 2019 18:49:41 +0000 (12:49 -0600)
committerWolfgang Bangerth <bangerth@colostate.edu>
Wed, 21 Aug 2019 18:49:41 +0000 (12:49 -0600)
include/deal.II/base/tensor_polynomials_base.h
include/deal.II/fe/fe_poly.h
include/deal.II/fe/fe_poly_tensor.h

index cbd82f376720feeb8f941797795c1523f160aad5..e672f71cdff58c727e44072577e6fe315097b2e5 100644 (file)
@@ -30,8 +30,9 @@ DEAL_II_NAMESPACE_OPEN
 /**
  * This class provides a framework for the finite element polynomial
  * classes for use with finite element classes that are derived from
- * @p FE_Poly and @p FE_PolyTensor. An object of this type is stored
- * as a member variable in the finite element class.
+ * FE_PolyTensor. An object of this type (or rather of a type derived
+ * from this class) is stored as a member variable each object of
+ * type FE_PolyTensor.
  *
  * <h3>Deriving classes</h3>
  *
index 1f299f03faa053faa778465ad183ec1b061e6e4d..57a4419522208dfecf3c9d21161afad8c7424228 100644 (file)
@@ -29,8 +29,10 @@ DEAL_II_NAMESPACE_OPEN
 
 /**
  * This class gives a unified framework for the implementation of
- * FiniteElement classes based on polynomial spaces like the
- * TensorProductPolynomials or PolynomialSpace classes.
+ * FiniteElement classes based on scalar polynomial spaces like the
+ * TensorProductPolynomials or PolynomialSpace classes. This
+ * class has a corresponding class for tensor-valued finite
+ * elements in the FE_PolyTensor class.
  *
  * Every class that has the following public member variables and
  * functions can be used as template parameter @p PolynomialType.
index 1fa69c4156788879e06cb69a9b0f1d878281b822..4b71a96b4b28d3b6ef0b91be8a93f42075db5251 100644 (file)
 DEAL_II_NAMESPACE_OPEN
 
 /**
- * This class gives a unified framework for the implementation of
- * FiniteElement classes based on Tensor valued polynomial spaces like
- * PolynomialsBDM and PolynomialsRaviartThomas.
+ * This class provides a unified framework for the implementation of
+ * FiniteElement classes based on tensor-valued polynomial spaces like
+ * PolynomialsBDM and PolynomialsRaviartThomas. In this, it is the
+ * tensor-valued equivalent of the FE_Poly class.
  *
  * In essence, what this class requires is that a derived class describes
  * to it a (vector-valued) polynomial space in which every polynomial
- * has exactly @p dim vector components. The polynomial space is described
- * through the @p PolynomialType template argument, which needs to provide
- * a function of the following signature:
- * @code
- * void compute (const Point<dim>            &unit_point,
- *               std::vector<Tensor<1,dim> > &values,
- *               std::vector<Tensor<2,dim> > &grads,
- *               std::vector<Tensor<3,dim> > &grad_grads) const;
- * @endcode
- *
- * For more information on the template parameter <tt>spacedim</tt>, see the
- * documentation for the class Triangulation.
+ * has exactly @p dim vector components. The classes that provide such
+ * implementations are all derived from the TensorPolynomialsBase
+ * class, and an object of one of these derived types needs to be
+ * provided to the constructor of this class.
  *
  *
  * <h3>Deriving classes</h3>
@@ -58,13 +51,16 @@ DEAL_II_NAMESPACE_OPEN
  * This class is not a fully implemented FiniteElement class, but implements
  * some common features of vector valued elements based on vector valued
  * polynomial classes. What's missing here in particular is information on the
- * topological location of the node values, and derived classes need to provide
+ * topological location of the node values (i.e., whether a degree of freedom
+ * is logically at a vertex, edge, face, or the interior of a cell --
+ * information that determines the continuity properties of the associated
+ * shape functions across cell interfaces), and derived classes need to provide
  * this information.
  *
  * Similarly, in many cases, node functionals depend on the shape of the mesh
  * cell, since they evaluate normal or tangential components on the faces. In
  * order to allow for a set of transformations, the variable #mapping_kind has
- * been introduced. It should needs be set in the constructor of a derived
+ * been introduced. It needs be set in the constructor of a derived
  * class.
  *
  * Any derived class must decide on the polynomial space to use.  This
@@ -138,7 +134,7 @@ DEAL_II_NAMESPACE_OPEN
  * mappings, then @p mapping_kind may be a vector with the same number
  * of elements as there are shape functions.
  *
- * @see PolynomialsBDM, PolynomialsRaviartThomas
+ * @see TensorPolynomialsBase
  * @ingroup febase
  * @author Guido Kanschat
  * @date 2005

In the beginning the Universe was created. This has made a lot of people very angry and has been widely regarded as a bad move.

Douglas Adams


Typeset in Trocchi and Trocchi Bold Sans Serif.