* For 1D, the quadrature rule degenerates to a
* `dealii::QGauss<1>(n_points_1D)`.
*
- * @ingroup simplex
- *
* @note The quadrature rules implemented by this class come from a variety of
* sources, but all of them have positive quadrature weights.
*
* respect to the vertices - i.e., the locations of the mapped quadrature points
* depends on the numbering of the cell vertices. If you need rules that are
* independent of the vertex numbering then use QWitherdenVincentSimplex.
+ *
+ * @relates simplex
*/
template <int dim>
class QGaussSimplex : public QSimplex<dim>
* @note Some rules (2D 2 odd and 3D 2 even) do not yet exist and instead a
* higher-order rule is used in their place.
*
- * @ingroup simplex
+ * @relates simplex
*/
template <int dim>
class QWitherdenVincentSimplex : public QSimplex<dim>
*
* @note Only implemented for 3D.
*
- * @ingroup simplex
+ * @relates simplex
*/
template <int dim, int spacedim = dim>
class FE_PyramidPoly : public dealii::FE_Poly<dim, spacedim>
* @note Currently, only linear polynomials (degree=1) are implemented. See
* also the documentation of ScalarLagrangePolynomialPyramid.
*
- * @ingroup simplex
+ * @relates simplex
*/
template <int dim, int spacedim = dim>
class FE_PyramidP : public FE_PyramidPoly<dim, spacedim>
* @note Currently, only linear polynomials (degree=1) are implemented. See
* also the documentation of ScalarLagrangePolynomialPyramid.
*
- * @ingroup simplex
+ * @relates simplex
*/
template <int dim, int spacedim = dim>
class FE_PyramidDGP : public FE_PyramidPoly<dim, spacedim>
*
* @note Only implemented for 2D and 3D.
*
- * @ingroup simplex
+ * @relates simplex
*/
template <int dim, int spacedim = dim>
class FE_SimplexPoly : public dealii::FE_Poly<dim, spacedim>
* the finite element space of continuous, piecewise polynomials of
* degree $k$.
*
- * @ingroup simplex
+ * @relates simplex
*/
template <int dim, int spacedim = dim>
class FE_SimplexP : public FE_SimplexPoly<dim, spacedim>
* element space of discontinuous, piecewise polynomials of degree
* $k$.
*
- * @ingroup simplex
+ * @relates simplex
*/
template <int dim, int spacedim = dim>
class FE_SimplexDGP : public FE_SimplexPoly<dim, spacedim>
*
* @note Only implemented for 3D.
*
- * @ingroup simplex
+ * @relates simplex
*/
template <int dim, int spacedim = dim>
class FE_WedgePoly : public dealii::FE_Poly<dim, spacedim>
* (degree=2) are implemented. See also the documentation of
* ScalarLagrangePolynomialWedge.
*
- * @ingroup simplex
+ * @relates simplex
*/
template <int dim, int spacedim = dim>
class FE_WedgeP : public FE_WedgePoly<dim, spacedim>
* (degree=2) are implemented. See also the documentation of
* ScalarLagrangePolynomialWedge.
*
- * @ingroup simplex
+ * @relates simplex
*/
template <int dim, int spacedim = dim>
class FE_WedgeDGP : public FE_WedgePoly<dim, spacedim>
* @note Currently, only implemented for elements with tensor_degree==1 and
* n_components==1.
*
- * @ingroup simplex
+ * @relates simplex
*/
template <int dim, int spacedim = dim>
class MappingFE : public Mapping<dim, spacedim>
* out_tria.set_manifold(i, in_tria.get_manifold(i));
* @endcode
*
- * @ingroup simplex
+ * @relates simplex
*/
template <int dim, int spacedim>
void
*
* @note Currently, this function only works for `dim==spacedim`.
*
- * @ingroup simplex
+ * @relates simplex
*/
template <int dim, int spacedim>
void
* quadrilateral/hexahedral cells and subdivides these into 2/5
* triangular/tetrahedral cells.
*
- * @ingroup simplex
+ * @relates simplex
*/
template <int dim, int spacedim>
void
* The companion GridOut::write_vtk function can be used to write VTK files
* compatible with this method.
*
- * @ingroup simplex
+ * @relates simplex
*/
void
read_vtk(std::istream &in);
* Read grid data from an msh file. The %Gmsh formats are documented at
* http://www.gmsh.info/.
*
- * @ingroup simplex
+ * @relates simplex
*/
void
read_msh(std::istream &in);
* as a boundary or material id. Physical surface numbers created in Gmsh,
* which can be seen in the .geo file, become material IDs.
*
- * @ingroup simplex
+ * @relates simplex
*/
void
read_msh(const std::string &filename);
* @image html "comsol-mesh-boundary-lines.png"
* @image html "comsol-mesh-boundary-triangles.png"
*
- * @ingroup simplex
+ * @relates simplex
*/
void
read_comsol_mphtxt(std::istream &in);