]> https://gitweb.dealii.org/ - dealii.git/commitdiff
More links into the glossary.
authorWolfgang Bangerth <bangerth@math.tamu.edu>
Sat, 4 Aug 2012 21:40:00 +0000 (21:40 +0000)
committerWolfgang Bangerth <bangerth@math.tamu.edu>
Sat, 4 Aug 2012 21:40:00 +0000 (21:40 +0000)
git-svn-id: https://svn.dealii.org/trunk@25749 0785d39b-7218-0410-832d-ea1e28bc413d

deal.II/include/deal.II/fe/fe.h
deal.II/include/deal.II/fe/fe_abf.h
deal.II/include/deal.II/fe/fe_bdm.h
deal.II/include/deal.II/fe/fe_dg_vector.h
deal.II/include/deal.II/fe/fe_nedelec.h
deal.II/include/deal.II/fe/fe_raviart_thomas.h

index cd900b3507315005c22043f86ed6408d734baf51..63ebb18a036baab267dec13996dd5b9cd1b7b1c4 100644 (file)
@@ -288,6 +288,8 @@ namespace hp
  * FETools::compute_node_matrix(). It relies on the existence of
  * #generalized_support_points and implementation of interpolate()
  * with VectorSlice argument.
+ * See the @ref GlossGeneralizedSupport "glossary entry on generalized support points"
+ * for more information.
  *
  * The piece of code in the constructor of a finite element
  * responsible for this looks like
@@ -1755,6 +1757,9 @@ class FiniteElement : public Subscriptor,
                                      /**
                                       * Return a support point vector
                                       * for generalized interpolation.
+                                     *
+                                     * See the @ref GlossGeneralizedSupport "glossary entry on generalized support points"
+                                     * for more information.
                                       */
     const std::vector<Point<dim> > &
     get_generalized_support_points () const;
@@ -1765,6 +1770,9 @@ class FiniteElement : public Subscriptor,
                                       * vectors either from
                                       * get_unit_support_points() or
                                       * get_generalized_support_points().
+                                     *
+                                     * See the @ref GlossGeneralizedSupport "glossary entry on generalized support points"
+                                     * for more information.
                                       */
     bool has_generalized_support_points () const;
 
index 4513bdd8914e97f80751ec3ef2fe2173dceecca7..9bf152acfbef84f571d972ee4db93fecee1994d9 100644 (file)
@@ -88,6 +88,8 @@ template <int dim, int spacedim> class MappingQ;
  * sufficient accuracy. The points needed are those of
  * QGauss<sub>k+1</sub> on each face as well as QGauss<sub>k</sub> in
  * the interior of the cell (or none for RT<sub>0</sub>).
+ * See the @ref GlossGeneralizedSupport "glossary entry on generalized support points"
+ * for more information.
  *
  *
  * @author Oliver Kayser-Herold, 2006, based on previous work
@@ -171,6 +173,9 @@ class FE_ABF : public FE_PolyTensor<PolynomialsABF<dim>, dim>
                                       * (#boundary_weights and
                                       * #interior_weights). Called
                                       * from the constructor.
+                                     *
+                                     * See the @ref GlossGeneralizedSupport "glossary entry on generalized support points"
+                                     * for more information.
                                       */
     void initialize_support_points (const unsigned int rt_degree);
 
index 152af7ee9887a4dc03e984b1518582130ed6883f..885af7af8f302afe8c9620f1f9e20a89ec5bc20e 100644 (file)
@@ -110,6 +110,8 @@ class FE_BDM
                                       * and FiniteElement<dim>::generalized_face_support_points
                                       * fields. Called from the
                                       * constructor.
+                                     * See the @ref GlossGeneralizedSupport "glossary entry on generalized support points"
+                                     * for more information.
                                       */
     void initialize_support_points (const unsigned int rt_degree);
                                      /**
index 132f551ecf0a9b08abf4b3974530e600af8b0e4c..2cba9947884406a9ea4511c9f80c1ce6758d634c 100644 (file)
@@ -116,6 +116,9 @@ class FE_DGVector
                                       * class and fill the tables with
                                       * @p interior_weights. Called
                                       * from the constructor.
+                                     *
+                                     * See the @ref GlossGeneralizedSupport "glossary entry on generalized support points"
+                                     * for more information.
                                       */
     void initialize_support_points (const unsigned int degree);
 
index 7874f6235800708097e0817f87477564606dc195..aef972339b0b9d748d392714a31d4f334244b3f5 100644 (file)
@@ -392,6 +392,9 @@ class FE_Nedelec : public FE_PolyTensor<PolynomialsNedelec<dim>, dim>
                                       * #generalized_face_support_points
                                       * when computing the
                                       * integration.
+                                     *
+                                     * See the @ref GlossGeneralizedSupport "glossary entry on generalized support points"
+                                     * for more information.
                                       */
     Table<2, double> boundary_weights;
 
index 0302cc3202fb74d22e488c6e14e7af4ef3dafcee..525e7bcddfecacc325b3cb0dac5b2e6e0698fcb8 100644 (file)
@@ -252,6 +252,9 @@ class FE_RaviartThomas
                                       * face support point and one
                                       * column for each degree of
                                       * freedom on the face.
+                                     *
+                                     * See the @ref GlossGeneralizedSupport "glossary entry on generalized support points"
+                                     * for more information.
                                       */
     Table<2, double> boundary_weights;
                                      /**
@@ -413,6 +416,9 @@ class FE_RaviartThomasNodal
                                       * and FiniteElement<dim>::generalized_face_support_points
                                       * fields. Called from the
                                       * constructor.
+                                     *
+                                     * See the @ref GlossGeneralizedSupport "glossary entry on generalized support points"
+                                     * for more information.
                                       */
     void initialize_support_points (const unsigned int rt_degree);
 };

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.