]> https://gitweb.dealii.org/ - dealii.git/commitdiff
documentation improved
authorGuido Kanschat <dr.guido.kanschat@gmail.com>
Tue, 28 Dec 2004 17:41:01 +0000 (17:41 +0000)
committerGuido Kanschat <dr.guido.kanschat@gmail.com>
Tue, 28 Dec 2004 17:41:01 +0000 (17:41 +0000)
git-svn-id: https://svn.dealii.org/trunk@9863 0785d39b-7218-0410-832d-ea1e28bc413d

deal.II/deal.II/include/fe/fe_dgq.h

index de703360f07e734178146509af2e014596ede6ac..63ab0f81141819a205117012e9e249b5e799312d 100644 (file)
@@ -29,8 +29,8 @@ template <int dim> class MappingQ;
  * This is a discontinuous finite element based on tensor products of
  * Lagrangian polynomials. The shape functions are Lagrangian
  * interpolants of an equidistant grid of points on the unit cell. The
- * points are numbered in lexicographical order, with @p x running
- * fastest, then @p y, then @z (if these coordinates are present for a
+ * points are numbered in lexicographical order, with <i>x</i> running
+ * fastest, then <i>y</i>, then <i>z</i> (if these coordinates are present for a
  * given space dimension at all). For example, these are the node
  * orderings for <tt>FE_DGQ(1)</tt> in 3d:
  *  @verbatim
@@ -65,7 +65,7 @@ template <int dim> class MappingQ;
  * since there are no continuity requirements for these shape
  * functions across cell boundaries.
  *
- * @author Ralf Hartmann, 2001, 2004, Guido Kanschat 2001
+ * @author Ralf Hartmann, Guido Kanschat 2001, 2004
  */
 template <int dim>
 class FE_DGQ : public FE_Poly<TensorProductPolynomials<dim>,dim>
@@ -73,7 +73,7 @@ class FE_DGQ : public FE_Poly<TensorProductPolynomials<dim>,dim>
   public:
                                     /**
                                      * Constructor for tensor product
-                                     * polynomials of degree @p p.
+                                     * polynomials of degree <tt>p</tt>.
                                      */
     FE_DGQ (const unsigned int p);
     
@@ -81,8 +81,8 @@ class FE_DGQ : public FE_Poly<TensorProductPolynomials<dim>,dim>
                                      * Return a string that uniquely
                                      * identifies a finite
                                      * element. This class returns
-                                     * @p FE_DGQ<dim>(degree) , with
-                                     * @p dim and @p degree
+                                     * <tt>FE_DGQ<dim>(degree)</tt> , with
+                                     * <tt>dim</tt> and <tt>degree</tt>
                                      * replaced by appropriate
                                      * values.
                                      */

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.