Skip to content

Commit

Permalink
Merge pull request #17011 from bangerth/link-fes
Browse files Browse the repository at this point in the history
Link FE_Q, FE_SimplexP, and friends in the documentation.
  • Loading branch information
kronbichler committed May 15, 2024
2 parents 6224a7a + e93953a commit f3748b1
Show file tree
Hide file tree
Showing 4 changed files with 14 additions and 5 deletions.
4 changes: 3 additions & 1 deletion include/deal.II/fe/fe_pyramid_p.h
Original file line number Diff line number Diff line change
Expand Up @@ -54,7 +54,9 @@ class FE_PyramidPoly : public dealii::FE_Poly<dim, spacedim>
/**
* 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.
Expand Down
8 changes: 6 additions & 2 deletions include/deal.II/fe/fe_q.h
Original file line number Diff line number Diff line change
Expand Up @@ -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
Expand Down
3 changes: 2 additions & 1 deletion include/deal.II/fe/fe_simplex_p.h
Original file line number Diff line number Diff line change
Expand Up @@ -122,7 +122,8 @@ class FE_SimplexPoly : public dealii::FE_Poly<dim, spacedim>
/**
* 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".
Expand Down
4 changes: 3 additions & 1 deletion include/deal.II/fe/fe_wedge_p.h
Original file line number Diff line number Diff line change
Expand Up @@ -54,7 +54,9 @@ class FE_WedgePoly : public dealii::FE_Poly<dim, spacedim>
/**
* 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
Expand Down

0 comments on commit f3748b1

Please sign in to comment.