]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Link FE_Q, FE_SimplexP, and friends in the documentation. 17011/head
authorWolfgang Bangerth <bangerth@colostate.edu>
Sun, 12 May 2024 18:11:12 +0000 (12:11 -0600)
committerWolfgang Bangerth <bangerth@colostate.edu>
Sun, 12 May 2024 18:11:49 +0000 (12:11 -0600)
include/deal.II/fe/fe_pyramid_p.h
include/deal.II/fe/fe_q.h
include/deal.II/fe/fe_simplex_p.h
include/deal.II/fe/fe_wedge_p.h

index af8cdea7280d030974bb26df384143d3f077e26f..959337611326b85b7ee9ba049bc8f6bc7346bbe2 100644 (file)
@@ -54,7 +54,9 @@ public:
 /**
  * Implementation of a scalar Lagrange finite element on a pyramid that yields
  * the finite element space of continuous, piecewise polynomials of
- * degree $k$.
+ * degree $k$. The corresponding element on simplex (triangular or tetrahedral)
+ * cells is FE_SimplexP, on hypercube cells it is FE_Q, and
+ * on wedges it is FE_WedgeP.
  *
  * @note Currently, only linear polynomials (degree=1) are implemented. See
  * also the documentation of ScalarLagrangePolynomialPyramid.
index aa4c2efa83be8b26e6a6bfb07cc5fe4043cb61f6..0e9e948e63bd3ed43cce350eaeb305ee5bc99b1b 100644 (file)
@@ -30,11 +30,15 @@ DEAL_II_NAMESPACE_OPEN
  */
 
 /**
- * Implementation of a scalar Lagrange finite element @p Qp that yields the
+ * This class provides an implementation of the scalar Lagrange $Q_p$ finite
+ * element on hypercube (line segments, quadrilaterals, or hexahedra) cells that
+ * yields the
  * finite element space of continuous, piecewise polynomials of degree @p p in
  * each coordinate direction. This class is realized using tensor product
  * polynomials based on 1d Lagrange polynomials with equidistant (degree up to
- * 2), Gauss-Lobatto (starting from degree 3), or given support points.
+ * 2), Gauss-Lobatto (starting from degree 3), or given support points. The
+ * corresponding element on simplex (triangular or tetrahedral) cells is
+ * FE_SimplexP, whereas on other cell kinds it is FE_WedgeP and FE_PyramidP.
  *
  * The standard constructor of this class takes the degree @p p of this finite
  * element. Alternatively, it can take a quadrature formula @p points defining
index de1df4cf8e530d954df7393f8b7c724f295d088e..05f55e45698cde6e27cf2fdd63b1adea44410d5b 100644 (file)
@@ -122,7 +122,8 @@ protected:
 /**
  * Implementation of a scalar Lagrange finite element $P_k$ that yields
  * the finite element space of continuous, piecewise polynomials of
- * degree $k$.
+ * degree $k$. The corresponding element on hypercube cells is FE_Q, on
+ * wegdes it is FE_WedgeP, and on pyramids it is FE_PyramidP.
  *
  * Also see
  * @ref simplex "Simplex support".
index 9006d3ecbbd6617c739ec5453725b01ac0aa55d5..75d4f28b1feee8ad23f74a6464d708d6c6fd103e 100644 (file)
@@ -54,7 +54,9 @@ public:
 /**
  * Implementation of a scalar Lagrange finite element on a wedge that yields
  * the finite element space of continuous, piecewise polynomials of
- * degree $k$.
+ * degree $k$. The corresponding element on simplex (triangular or tetrahedral)
+ * cells is FE_SimplexP, on hypercube cells it is FE_Q, and
+ * on pyramids it is FE_PyramidP.
  *
  * @note Currently, only linear (degree=1) and quadratic polynomials
  *   (degree=2) are implemented. See also the documentation of

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.