From cabf603107a35c8d3729681a1290aee67c9f9627 Mon Sep 17 00:00:00 2001 From: wolf Date: Sun, 31 Oct 1999 14:22:14 +0000 Subject: [PATCH] Doc updates. git-svn-id: https://svn.dealii.org/trunk@1809 0785d39b-7218-0410-832d-ea1e28bc413d --- .../deal.II/include/fe/fe_lib.criss_cross.h | 2 +- deal.II/deal.II/include/fe/q1_mapping.h | 24 ++++++++++--------- 2 files changed, 14 insertions(+), 12 deletions(-) diff --git a/deal.II/deal.II/include/fe/fe_lib.criss_cross.h b/deal.II/deal.II/include/fe/fe_lib.criss_cross.h index a0cf2ea66c..bde4619c9a 100644 --- a/deal.II/deal.II/include/fe/fe_lib.criss_cross.h +++ b/deal.II/deal.II/include/fe/fe_lib.criss_cross.h @@ -143,7 +143,7 @@ * 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. * diff --git a/deal.II/deal.II/include/fe/q1_mapping.h b/deal.II/deal.II/include/fe/q1_mapping.h index 2b88ab4cb8..432ca5c8bf 100644 --- a/deal.II/deal.II/include/fe/q1_mapping.h +++ b/deal.II/deal.II/include/fe/q1_mapping.h @@ -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 class FEQ1Mapping : public FiniteElement @@ -30,12 +32,12 @@ class FEQ1Mapping : public FiniteElement * 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 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 &restriction_is_additive_flags); /** * Return the value of the #i#th shape @@ -45,8 +47,8 @@ class FEQ1Mapping : public FiniteElement * computation of the transformation from * unit cell to real space cell. */ - virtual double shape_value_transform (const unsigned int i, - const Point &p) const; + virtual double shape_value_transform (const unsigned int i, + const Point &p) const; /** * Return the gradient of the #i#th shape @@ -56,8 +58,8 @@ class FEQ1Mapping : public FiniteElement * computation of the transformation from * unit cell to real space cell. */ - virtual Tensor<1,dim> shape_grad_transform (const unsigned int i, - const Point &p) const; + virtual Tensor<1,dim> shape_grad_transform (const unsigned int i, + const Point &p) const; /** * Refer to the base class for detailed @@ -98,7 +100,7 @@ class FEQ1Mapping : public FiniteElement * information on this function. */ virtual void get_normal_vectors (const DoFHandler::cell_iterator &cell, - const unsigned int face_no, + const unsigned int face_no, const vector > &unit_points, vector > &normal_vectors) const; -- 2.39.5