]> https://gitweb.dealii.org/ - dealii-svn.git/commitdiff
Update comments
authorbangerth <bangerth@0785d39b-7218-0410-832d-ea1e28bc413d>
Mon, 28 Aug 2006 19:48:29 +0000 (19:48 +0000)
committerbangerth <bangerth@0785d39b-7218-0410-832d-ea1e28bc413d>
Mon, 28 Aug 2006 19:48:29 +0000 (19:48 +0000)
git-svn-id: https://svn.dealii.org/trunk@13769 0785d39b-7218-0410-832d-ea1e28bc413d

deal.II/deal.II/include/fe/fe_dgp.h
deal.II/deal.II/include/fe/fe_dgp_monomial.h

index da97d7799728054a1c75e3956c17b48ef1a95aea..bf38c7d0ccd3d90da8ab8384734b8af11cfd56ee 100644 (file)
@@ -26,9 +26,18 @@ template <int dim> class MappingQ;
  * Discontinuous finite elements based on Legendre polynomials.
  *
  * This finite element implements complete polynomial spaces, that is,
- * dim-dimensional polynomials of degree p. The underlying
- * polynomials form a Legendre basis on the unit square. Thus, the
- * mass matrix is diagonal, if the grid cells are parallelograms.
+ * dim-dimensional polynomials of degree p. For example, in 2d the
+ * element FE_DGP(1) would represent the span of the functions
+ * $\{1,\hat x,\hat y\}$, which is in contrast to the element FE_DGQ(1)
+ * that is formed by the span of $\{1,\hat x,\hat y,\hat x\hat y\}$. Since the
+ * DGP space has only three unknowns for each quadrilateral, it is
+ * immediately clear that this element can not be continuous.
+ *
+ * The basis functions for this element are chosen to form a Legendre
+ * basis on the unit square. Thus, the mass matrix is diagonal, if the
+ * grid cells are parallelograms. Note that this is in contrast to the
+ * FE_DGPMonomial class that actually uses the monomial basis listed
+ * above as basis functions.
  *
  * The shape functions are defined in the class PolynomialSpace. The
  * polynomials used inside PolynomialSpace are Polynomials::Legendre
@@ -36,6 +45,16 @@ template <int dim> class MappingQ;
  * basis functions, refer to PolynomialSpace, remebering that the
  * Legendre polynomials are ordered by ascending degree.
  *
+ *
+ * <h3>Transformation properties</h3>
+ *
+ * It is worth noting that under a (bi-, tri-)linear mapping, the
+ * space described by this element does not contain $P(k)$, even if we
+ * use a basis of polynomials of degree $k$. Consequently, for
+ * example, on meshes with non-affine cells, a linear function can not
+ * be exactly represented by elements of type FE_DGP(1) or
+ * FE_DGPMonomial(1).
+ *
  * @author Guido Kanschat, 2001, 2002, Ralf Hartmann 2004
  */
 template <int dim>
index 6e041c822d27f8ba198450a8e768015ad5057590..114c87a22fc5fdc9428aad905c26f84b655d60be 100644 (file)
@@ -24,14 +24,37 @@ template <int dim> class MappingQ;
 /*@{*/
 
 /**
- * Discontinuous finite elements based on monomials of degree up to
- * <tt>p</tt>.
+ * Discontinuous finite elements based on monomials.
  *
- * This finite element makes use of the PolynomialsP class which
- * implements <tt>dim</tt>-dimensional polynomials of degree
- * <tt>p</tt> based the Polynomials::Polynomial and the
- * PolynomialSpace classes.
+ * This finite element implements complete polynomial spaces, that is,
+ * dim-dimensional polynomials of degree p. For example, in 2d the
+ * element FE_DGP(1) would represent the span of the functions
+ * $\{1,\hat x,\hat y\}$, which is in contrast to the element FE_DGQ(1)
+ * that is formed by the span of $\{1,\hat x,\hat y,\hat x\hat y\}$. Since the
+ * DGP space has only three unknowns for each quadrilateral, it is
+ * immediately clear that this element can not be continuous.
  *
+ * The basis functions for this element are chosen to be the monomials
+ * listed above. Note that this is the main difference to the FE_DGP
+ * class that uses a set of polynomials of complete degree
+ * <code>p</code> that form a Legendre basis on the unit square. Thus,
+ * there, the mass matrix is diagonal, if the grid cells are
+ * parallelograms. The basis here does not have this property;
+ * however, it is simpler to compute. On the other hand, this element
+ * has the additional disadvantage that the local cell matrices
+ * usually have a worse condition number than the ones originating
+ * from the FE_DGP element.
+ *
+ *
+ * <h3>Transformation properties</h3>
+ *
+ * It is worth noting that under a (bi-, tri-)linear mapping, the
+ * space described by this element does not contain $P(k)$, even if we
+ * use a basis of polynomials of degree $k$. Consequently, for
+ * example, on meshes with non-affine cells, a linear function can not
+ * be exactly represented by elements of type FE_DGP(1) or
+ * FE_DGPMonomial(1).
+ * 
  * @author Ralf Hartmann, 2004
  */
 template <int dim>

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.