]> https://gitweb.dealii.org/ - dealii-svn.git/commitdiff
Doc updates.
authorwolf <wolf@0785d39b-7218-0410-832d-ea1e28bc413d>
Sun, 31 Oct 1999 14:22:14 +0000 (14:22 +0000)
committerwolf <wolf@0785d39b-7218-0410-832d-ea1e28bc413d>
Sun, 31 Oct 1999 14:22:14 +0000 (14:22 +0000)
git-svn-id: https://svn.dealii.org/trunk@1809 0785d39b-7218-0410-832d-ea1e28bc413d

deal.II/deal.II/include/fe/fe_lib.criss_cross.h
deal.II/deal.II/include/fe/q1_mapping.h

index a0cf2ea66c410c3c89aee92e2b88ea88d478522b..bde4619c9a19ad7c86ace749d39d358d3f57b2fa 100644 (file)
  * the same number of degrees of freedoms.
  *
  * Apart from all this data, it must not be forgotten that we cannot
- * expect superconvergence neither in the Gauss points not in the vertices.
+ * expect superconvergence neither in the Gauss points nor in the vertices.
  * Thus we may improve the accuracy of the solution obtained with the linear
  * element by a postprocess, while we can't do so for the criss-cross element.
  *
index 2b88ab4cb8d7c26e7d1735e7344991a489db76c4..432ca5c8bf83320a4beae083f5d3a8b84b816734 100644 (file)
@@ -17,6 +17,8 @@
  * All finite element classes using a Q1 mapping of the grid cell to the
  * unit cell may be derived from this class. The grid transformation functions
  * are implemented here and do not have to be taken care of later.
+ *
+ * @author Wolfgang Bangerth, 1998
  */
 template <int dim>
 class FEQ1Mapping : public FiniteElement<dim>
@@ -30,12 +32,12 @@ class FEQ1Mapping : public FiniteElement<dim>
                                      * two space dimensions, #dofs_per_hex#
                                      * shall be zero.
                                      */
-    FEQ1Mapping (const unsigned int dofs_per_vertex,
-                const unsigned int dofs_per_line,
-                const unsigned int dofs_per_quad,
-                const unsigned int dofs_per_hex,
-                const unsigned int n_components,
-                const vector<bool> restriction_is_additive_flags);
+    FEQ1Mapping (const unsigned int  dofs_per_vertex,
+                const unsigned int  dofs_per_line,
+                const unsigned int  dofs_per_quad,
+                const unsigned int  dofs_per_hex,
+                const unsigned int  n_components,
+                const vector<bool> &restriction_is_additive_flags);
 
                                     /**
                                      * Return the value of the #i#th shape
@@ -45,8 +47,8 @@ class FEQ1Mapping : public FiniteElement<dim>
                                      * computation of the transformation from
                                      * unit cell to real space cell.
                                      */
-    virtual double shape_value_transform (const unsigned int i,
-                                         const Point<dim> &p) const;
+    virtual double shape_value_transform (const unsigned int  i,
+                                         const Point<dim>   &p) const;
 
                                     /**
                                      * Return the gradient of the #i#th shape
@@ -56,8 +58,8 @@ class FEQ1Mapping : public FiniteElement<dim>
                                      * computation of the transformation from
                                      * unit cell to real space cell.
                                      */
-    virtual Tensor<1,dim> shape_grad_transform (const unsigned int i,
-                                               const Point<dim> &p) const;
+    virtual Tensor<1,dim> shape_grad_transform (const unsigned int  i,
+                                               const Point<dim>   &p) const;
 
                                     /**
                                      * Refer to the base class for detailed
@@ -98,7 +100,7 @@ class FEQ1Mapping : public FiniteElement<dim>
                                      * information on this function.
                                      */
     virtual void get_normal_vectors (const DoFHandler<dim>::cell_iterator &cell,
-                                    const unsigned int          face_no,
+                                    const unsigned int           face_no,
                                     const vector<Point<dim-1> > &unit_points,
                                     vector<Point<dim> >         &normal_vectors) const;
 

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.