]> https://gitweb.dealii.org/ - dealii-svn.git/commitdiff
FELinearMapping moved to FEQ1Mapping
authorguido <guido@0785d39b-7218-0410-832d-ea1e28bc413d>
Tue, 11 May 1999 14:40:26 +0000 (14:40 +0000)
committerguido <guido@0785d39b-7218-0410-832d-ea1e28bc413d>
Tue, 11 May 1999 14:40:26 +0000 (14:40 +0000)
git-svn-id: https://svn.dealii.org/trunk@1310 0785d39b-7218-0410-832d-ea1e28bc413d

12 files changed:
deal.II/deal.II/include/fe/fe_lib.dg.h
deal.II/deal.II/include/fe/fe_lib.lagrange.h
deal.II/deal.II/include/fe/fe_values.h
deal.II/deal.II/include/fe/q1_mapping.h [moved from deal.II/deal.II/include/fe/fe_linear_mapping.h with 92% similarity]
deal.II/deal.II/source/fe/fe_lib.criss_cross.cc
deal.II/deal.II/source/fe/fe_lib.cubic.cc
deal.II/deal.II/source/fe/fe_lib.dg.constant.cc
deal.II/deal.II/source/fe/fe_lib.linear.cc
deal.II/deal.II/source/fe/fe_lib.quadratic.cc
deal.II/deal.II/source/fe/fe_lib.quartic.cc
deal.II/deal.II/source/fe/q1_mapping.cc [moved from deal.II/deal.II/source/fe/fe_linear_mapping.cc with 91% similarity]
deal.II/deal.II/source/fe/q1_mapping.jacobians.cc [moved from deal.II/deal.II/source/fe/fe_linear_mapping.jacobians.cc with 99% similarity]

index 821f8975f386861693604d210168703a4f198901..7705e145bbb6b7c4ae74cc800c57f60da89e9d1e 100644 (file)
@@ -21,7 +21,7 @@
  * @author Ralf Hartmann, 1998
  */
 template <int dim>
-class FEDG_Q0 : public FELinearMapping<dim> {
+class FEDG_Q0 : public FEQ1Mapping<dim> {
   public:
                                     /**
                                      * Constructor
index d7c3754c7b413dd4e3815affc687eb84fd524a65..3aeedc3189e0158b78364bf5b3c7c884ab411211 100644 (file)
@@ -6,17 +6,10 @@
 /*----------------------------   fe_lib.h     ---------------------------*/
 
 
-#include <fe/fe_linear_mapping.h>
-
-#define FELinear FEQ1
-#define FEQuadraticSub FEQ2
-#define FECubicSub FEQ3
-#define FEQuarticSub FEQ4
+#include <fe/q1_mapping.h>
 
 /**
- * Define a (bi-, tri-, etc)linear finite element in #dim# space dimensions,
- * along with (bi-, tri-)linear (therefore isoparametric) transforms from the
- * unit cell to the real cell.
+ * Isoparametric Q1 finite element in #dim# space dimensions.
  *
  * The linear, isoparametric mapping from a point $\vec \xi$ on the unit cell
  * to a point $\vec x$ on the real cell is defined as
  * @author Wolfgang Bangerth, 1998, 1999
  */
 template <int dim>
-class FEQ1 : public FELinearMapping<dim> {
+class FEQ1
+  :
+  public FEQ1Mapping<dim>
+{
   public:
                                     /**
                                      * Constructor
@@ -42,7 +38,7 @@ class FEQ1 : public FELinearMapping<dim> {
                                     /**
                                      * Constructor that is called by the
                                      * constructor of the derived
-                                     * #FEDGLinear# class.
+                                     * #FEDG_Q1# class.
                                      * It uses  no dofs in the vertices and 
                                      * $2^d$ dofs per cell. No constraint
                                      * matrices are build.
@@ -129,8 +125,8 @@ class FEQ1 : public FELinearMapping<dim> {
 
 
 /**
- * Define a (bi-, tri-, etc)quadratic finite element in #dim# space dimensions.
- * A linear (subparametric) mapping from the unit cell
+ * Subparametric Q2 finite element in #dim# space dimensions.
+ * A Q1 mapping from the unit cell
  * to the real cell is implemented.
  *
  * The numbering of the degrees of freedom is as follows:
@@ -211,7 +207,10 @@ class FEQ1 : public FELinearMapping<dim> {
  * @author Wolfgang Bangerth, 1998, 1999
  */
 template <int dim>
-class FEQ2 : public FELinearMapping<dim> {
+class FEQ2
+  :
+  public FEQ1Mapping<dim>
+{
   public:
                                     /**
                                      * Constructor
@@ -307,8 +306,8 @@ class FEQ2 : public FELinearMapping<dim> {
 
 
 /**
- * Define a (bi-, tri-, etc)cubic finite element in #dim# space dimensions.
- * A linear (subparametric) mapping from the unit cell
+ * Subparametric Q3 finite element in #dim# space dimensions.
+ * A Q1 mapping from the unit cell
  * to the real cell is implemented.
  *
  * The numbering of degrees of freedom in one spatial dimension is as follows:
@@ -333,7 +332,10 @@ class FEQ2 : public FELinearMapping<dim> {
  * @author Wolfgang Bangerth, 1998
  */
 template <int dim>
-class FEQ3 : public FELinearMapping<dim> {
+class FEQ3
+  :
+  public FEQ1Mapping<dim>
+{
   public:
                                     /**
                                      * Constructor
@@ -428,7 +430,7 @@ class FEQ3 : public FELinearMapping<dim> {
 
 
 /**
- * Define a (bi-, tri-, etc)quartic finite element in #dim# space dimensions.
+ * Subparametric Q4 finite element in #dim# space dimensions.
  * A linear (subparametric) mapping from the unit cell
  * to the real cell is implemented.
  *
@@ -456,7 +458,10 @@ class FEQ3 : public FELinearMapping<dim> {
  * @author Wolfgang Bangerth, 1998
  */
 template <int dim>
-class FEQ4 : public FELinearMapping<dim> {
+class FEQ4
+  :
+  public FEQ1Mapping<dim>
+{
   public:
                                     /**
                                      * Constructor
index dec58f62f89b43b805e37a4616741eab5ec8c42e..de828c2a88e3a4d29eca83358c6ef120021c928b 100644 (file)
  *  \textit{from the right}; the whole situation is a bit confusing and it
  *  either takes deep though or trial-and-error to do it right. Some more
  *  information on this can be found in the source code documentation for the
- *  #FELinearMapping<dim>::fill_fe_values# function, where also a small test
+ *  #FEQ1Mapping<dim>::fill_fe_values# function, where also a small test
  *  program is presented.
  *
  *  The derivatives of the Jacobi matrices at the quadrature points with respect
similarity index 92%
rename from deal.II/deal.II/include/fe/fe_linear_mapping.h
rename to deal.II/deal.II/include/fe/q1_mapping.h
index 84177c9a698d52ab381aef8dc3469e231119bfc7..60b9ff60c26a61b076cbe2cf22af03838e99bc93 100644 (file)
@@ -1,10 +1,10 @@
-/*----------------------------   fe_linear_mapping.h     ---------------------------*/
+/*----------------------------   q1_mapping.h     ---------------------------*/
 /*      $Id$                 */
 /*      Copyright W. Bangerth, University of Heidelberg, 1998 */
-#ifndef __fe_linear_mapping_H
-#define __fe_linear_mapping_H
-/*----------------------------   fe_linear_mapping.h     ---------------------------*/
-
+#ifndef __fe_q1_mapping_H
+#define __fe_q1_mapping_H
+/*----------------------------   q1_mapping.h     ---------------------------*/
+// File has moved from fe_linear_mapping.h
 
 #include <cmath>
 #include <fe/fe.h>
@@ -19,7 +19,7 @@
  * are implemented here and do not have to be taken care of later.
  */
 template <int dim>
-class FELinearMapping
+class FEQ1Mapping
   :
   public FiniteElement<dim>
 {
@@ -32,7 +32,7 @@ class FELinearMapping
                                      * two space dimensions, #dofs_per_hex#
                                      * shall be zero.
                                      */
-    FELinearMapping (const unsigned int dofs_per_vertex,
+    FEQ1Mapping (const unsigned int dofs_per_vertex,
                     const unsigned int dofs_per_line,
                     const unsigned int dofs_per_quad=0,
                     const unsigned int dofs_per_hex =0,
@@ -181,7 +181,7 @@ class FELinearMapping
 
 
 
-/*----------------------------   fe_linear_mapping.h     ---------------------------*/
-/* end of #ifndef __fe_linear_mapping_H */
+/*----------------------------   q1_mapping.h     ---------------------------*/
+/* end of #ifndef __q1_mapping_H */
 #endif
-/*----------------------------   fe_linear_mapping.h     ---------------------------*/
+/*----------------------------   q1_mapping.h     ---------------------------*/
index eb0c56b093f72d0f6799a0778b19ce84daa7aaed..538128bd07432a4e3fa5bc6035cbe9d5c49316bd 100644 (file)
@@ -988,7 +988,7 @@ void FECrissCross<dim>::fill_fe_values (const DoFHandler<dim>::cell_iterator &ce
 
   The scheme laid down above was originally used. Due to recent advances
   in the authors understanding of most basic things, it was dropped and
-  replaced by the following version. See #FELinearMapping<dim>::fill_fe_values#
+  replaced by the following version. See #FEQ1Mapping<dim>::fill_fe_values#
   for more information on this.
 */
 
index 9fd04e15ac197f960e926323449934ce146e8779..2bcd5c41d56f495db76842fa2fdb7d62f58ba170 100644 (file)
@@ -21,7 +21,7 @@ template <> void FEQ3<deal_II_dimension>::initialize_matrices ();
 
 template <>
 FEQ3<1>::FEQ3 () :
-               FELinearMapping<1> (1, 2) {
+               FEQ1Mapping<1> (1, 2) {
   initialize_matrices ();
 };
 
@@ -29,7 +29,7 @@ FEQ3<1>::FEQ3 () :
 
 template <>
 FEQ3<1>::FEQ3 (const int) :
-               FELinearMapping<1> (0, 4)
+               FEQ1Mapping<1> (0, 4)
 {
   initialize_matrices ();
 };
@@ -240,7 +240,7 @@ void FEQ3<1>::get_local_mass_matrix (const DoFHandler<1>::cell_iterator &cell,
 
 template <>
 FEQ3<2>::FEQ3 () :
-               FELinearMapping<2> (1, 2, 4)
+               FEQ1Mapping<2> (1, 2, 4)
 {
   interface_constraints(0,0) = -1.0/16.0;
   interface_constraints(0,1) = -1.0/16.0;
@@ -264,7 +264,7 @@ FEQ3<2>::FEQ3 () :
 
 template <>
 FEQ3<2>::FEQ3 (const int) :
-               FELinearMapping<2> (0, 0, 16)
+               FEQ1Mapping<2> (0, 0, 16)
 {
   initialize_matrices ();
 };
@@ -1603,7 +1603,7 @@ void FEQ3<2>::get_face_support_points (const typename DoFHandler<2>::face_iterat
 
 template <>
 FEQ3<3>::FEQ3 () :
-               FELinearMapping<3> (1, 2, 4, 8)
+               FEQ1Mapping<3> (1, 2, 4, 8)
 {
       interface_constraints(0,0) = 1.0/256.0;
       interface_constraints(0,1) = 1.0/256.0;
@@ -1865,7 +1865,7 @@ FEQ3<3>::FEQ3 () :
 
 template <>
 FEQ3<3>::FEQ3 (const int) :
-               FELinearMapping<3> (0, 0, 0, 64)
+               FEQ1Mapping<3> (0, 0, 0, 64)
 {
   initialize_matrices ();
 };
index 700e54f419e9a86418cd826f25577dbe18239193..42a1e984b47ef9d969169b23ef893c4464d268bd 100644 (file)
@@ -14,7 +14,7 @@
 
 template <>
 FEDG_Q0<1>::FEDG_Q0 () :
-               FELinearMapping<1> (0, 1)
+               FEQ1Mapping<1> (0, 1)
 {
                                   // for restriction and prolongation matrices:
                                   // note that we do not add up all the
@@ -59,7 +59,7 @@ FEDG_Q0<1>::get_face_support_points (const typename DoFHandler<1>::face_iterator
 
 template <>
 FEDG_Q0<2>::FEDG_Q0 () :
-               FELinearMapping<2> (0, 0, 1)
+               FEQ1Mapping<2> (0, 0, 1)
 {
                                   // The restriction matrices got crazy values
                                   // as it is yet not clear how they should work
index 8a99e24f3cc113733772bbf73545cc93db3ebcd5..92e18c8ef28261fc69e0a9df5677ff578b82a4fb 100644 (file)
@@ -22,7 +22,7 @@ template <> void FEQ1<deal_II_dimension>::initialize_matrices ();
 
 template <>
 FEQ1<1>::FEQ1 () :
-               FELinearMapping<1> (1, 0)
+               FEQ1Mapping<1> (1, 0)
 {
   initialize_matrices ();
 };
@@ -30,7 +30,7 @@ FEQ1<1>::FEQ1 () :
 
 template <>
 FEQ1<1>::FEQ1 (const int) :
-               FELinearMapping<1> (0, 2)
+               FEQ1Mapping<1> (0, 2)
 {
   initialize_matrices ();
 };
@@ -165,7 +165,7 @@ void FEQ1<1>::get_local_mass_matrix (const DoFHandler<1>::cell_iterator &cell,
 
 template <>
 FEQ1<2>::FEQ1 () :
-               FELinearMapping<2> (1, 0, 0)
+               FEQ1Mapping<2> (1, 0, 0)
 {
   interface_constraints(0,0) = 1./2.;
   interface_constraints(0,1) = 1./2.;
@@ -177,7 +177,7 @@ FEQ1<2>::FEQ1 () :
 
 template <>
 FEQ1<2>::FEQ1 (const int) :
-               FELinearMapping<2> (0, 0, 4)
+               FEQ1Mapping<2> (0, 0, 4)
 {
   initialize_matrices ();
 };
@@ -433,7 +433,7 @@ void FEQ1<2>::get_unit_support_points (vector<Point<2> > &unit_points) const {
 
 template <>
 FEQ1<3>::FEQ1 () :
-               FELinearMapping<3> (1, 0, 0, 0)
+               FEQ1Mapping<3> (1, 0, 0, 0)
 {
   interface_constraints(0,0) = 1.0/4.0;
   interface_constraints(0,1) = 1.0/4.0;
@@ -455,7 +455,7 @@ FEQ1<3>::FEQ1 () :
 
 template <>
 FEQ1<3>::FEQ1 (const int) :
-               FELinearMapping<3> (0, 0, 0, 8)
+               FEQ1Mapping<3> (0, 0, 0, 8)
 {
   initialize_matrices ();
 };
index 88ee2e71320cf9ada1797e43f622a68461d3278e..58118041be8e9629307f390534531054dfcca897 100644 (file)
@@ -19,7 +19,7 @@ template <> void FEQ2<deal_II_dimension>::initialize_matrices ();
 
 template <>
 FEQ2<1>::FEQ2 () :
-               FELinearMapping<1> (1, 1) {
+               FEQ1Mapping<1> (1, 1) {
   initialize_matrices ();
 };
 
@@ -27,7 +27,7 @@ FEQ2<1>::FEQ2 () :
 
 template <>
 FEQ2<1>::FEQ2 (const int) :
-               FELinearMapping<1> (0, 3) {
+               FEQ1Mapping<1> (0, 3) {
   initialize_matrices ();
 };
 
@@ -232,7 +232,7 @@ void FEQ2<1>::get_local_mass_matrix (const DoFHandler<1>::cell_iterator &cell,
 
 template <>
 FEQ2<2>::FEQ2 () :
-               FELinearMapping<2> (1, 1, 1)
+               FEQ1Mapping<2> (1, 1, 1)
 {
   interface_constraints(0,2) = 1.0;
   interface_constraints(1,0) = 3./8.;
@@ -249,7 +249,7 @@ FEQ2<2>::FEQ2 () :
 
 template <>
 FEQ2<2>::FEQ2 (const int) :
-               FELinearMapping<2> (0, 0, 9)
+               FEQ1Mapping<2> (0, 0, 9)
 {
   initialize_matrices ();
 };
@@ -1121,7 +1121,7 @@ void FEQ2<2>::get_face_support_points (const typename DoFHandler<2>::face_iterat
 
 template <>
 FEQ2<3>::FEQ2 () :
-               FELinearMapping<3> (1, 1, 1, 1)
+               FEQ1Mapping<3> (1, 1, 1, 1)
 {
   interface_constraints(0,8) = 1.0;
   interface_constraints(1,4) = 1.0;
@@ -1208,7 +1208,7 @@ FEQ2<3>::FEQ2 () :
 
 template <>
 FEQ2<3>::FEQ2 (const int) :
-               FELinearMapping<3> (0, 0, 0, 27)
+               FEQ1Mapping<3> (0, 0, 0, 27)
 {
   initialize_matrices ();
 };
index e23f3fc1f9657d6dd03c028703cba6d2bcee60c3..26c4eac9fb3ed9b4112fb9e86b7aff6b69032665 100644 (file)
@@ -19,14 +19,14 @@ template <> void FEQ4<deal_II_dimension>::initialize_matrices ();
 
 template <>
 FEQ4<1>::FEQ4 () :
-               FELinearMapping<1> (1, 3) {
+               FEQ1Mapping<1> (1, 3) {
   initialize_matrices ();
 };
 
 
 template <>
 FEQ4<1>::FEQ4 (const int) :
-               FELinearMapping<1> (0, 5) {
+               FEQ1Mapping<1> (0, 5) {
   initialize_matrices ();
 };
 
@@ -218,7 +218,7 @@ void FEQ4<1>::get_local_mass_matrix (const DoFHandler<1>::cell_iterator &cell,
 
 template <>
 FEQ4<2>::FEQ4 () :
-               FELinearMapping<2> (1, 3, 9)
+               FEQ1Mapping<2> (1, 3, 9)
 {
   interface_constraints(0,3) = 1.0;
   interface_constraints(1,0) = 35.0/128.0;
@@ -251,7 +251,7 @@ FEQ4<2>::FEQ4 () :
 
 template <>
 FEQ4<2>::FEQ4 (const int) :
-               FELinearMapping<2> (0, 0, 25)
+               FEQ1Mapping<2> (0, 0, 25)
 {
   initialize_matrices ();
 };
similarity index 91%
rename from deal.II/deal.II/source/fe/fe_linear_mapping.cc
rename to deal.II/deal.II/source/fe/q1_mapping.cc
index 54d1b81514b3857e61440dedb9e4c72793f470cb..37fbed69052b4ee70d98d260d4463176f8a47d3f 100644 (file)
@@ -1,8 +1,9 @@
 /* $Id$ */
 /* Copyright W. Bangerth, University of Heidelberg, 1998 */
 
+// moved from file fe_linear_mapping.cc
 
-#include <fe/fe_linear_mapping.h>
+#include <fe/q1_mapping.h>
 #include <base/quadrature.h>
 #include <grid/tria_iterator.h>
 #include <grid/dof_accessor.h>
 
 
 
-/*---------------------------- FELinearMapping ----------------------------------*/
+/*---------------------------- FEQ1Mapping ----------------------------------*/
 
 
 
 #if deal_II_dimension == 1
 
 template <>
-FELinearMapping<1>::FELinearMapping (const unsigned int dofs_per_vertex,
+FEQ1Mapping<1>::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,
@@ -37,7 +38,7 @@ FELinearMapping<1>::FELinearMapping (const unsigned int dofs_per_vertex,
 template <>
 inline
 double
-FELinearMapping<1>::shape_value_transform (const unsigned int i,
+FEQ1Mapping<1>::shape_value_transform (const unsigned int i,
                                           const Point<1>     &p) const
 {
   Assert((i<2), ExcInvalidIndex(i));
@@ -55,7 +56,7 @@ FELinearMapping<1>::shape_value_transform (const unsigned int i,
 template <>
 inline
 Tensor<1,1>
-FELinearMapping<1>::shape_grad_transform(const unsigned int i,
+FEQ1Mapping<1>::shape_grad_transform(const unsigned int i,
                                         const Point<1>&) const
 {
   Assert((i<2), ExcInvalidIndex(i));
@@ -70,7 +71,7 @@ FELinearMapping<1>::shape_grad_transform(const unsigned int i,
 
 
 template <>
-void FELinearMapping<1>::get_face_jacobians (const DoFHandler<1>::face_iterator &,
+void FEQ1Mapping<1>::get_face_jacobians (const DoFHandler<1>::face_iterator &,
                                             const vector<Point<0> > &,
                                             vector<double>      &) const {
   Assert (false, ExcInternalError());
@@ -79,7 +80,7 @@ void FELinearMapping<1>::get_face_jacobians (const DoFHandler<1>::face_iterator
 
 
 template <>
-void FELinearMapping<1>::get_subface_jacobians (const DoFHandler<1>::face_iterator &,
+void FEQ1Mapping<1>::get_subface_jacobians (const DoFHandler<1>::face_iterator &,
                                                const unsigned int           ,
                                                const vector<Point<0> > &,
                                                vector<double>      &) const {
@@ -89,7 +90,7 @@ void FELinearMapping<1>::get_subface_jacobians (const DoFHandler<1>::face_iterat
 
 
 template <>
-void FELinearMapping<1>::get_normal_vectors (const DoFHandler<1>::cell_iterator &,
+void FEQ1Mapping<1>::get_normal_vectors (const DoFHandler<1>::cell_iterator &,
                                             const unsigned int,
                                             const vector<Point<0> > &,
                                             vector<Point<1> > &) const {
@@ -99,7 +100,7 @@ void FELinearMapping<1>::get_normal_vectors (const DoFHandler<1>::cell_iterator
 
 
 template <>
-void FELinearMapping<1>::get_normal_vectors (const DoFHandler<1>::cell_iterator &,
+void FEQ1Mapping<1>::get_normal_vectors (const DoFHandler<1>::cell_iterator &,
                                            const unsigned int,
                                            const unsigned int,
                                            const vector<Point<0> > &,
@@ -109,7 +110,7 @@ void FELinearMapping<1>::get_normal_vectors (const DoFHandler<1>::cell_iterator
 
 
 template <>
-void FELinearMapping<1>::fill_fe_values (const DoFHandler<1>::cell_iterator &cell,
+void FEQ1Mapping<1>::fill_fe_values (const DoFHandler<1>::cell_iterator &cell,
                                         const vector<Point<1> > &unit_points,
                                         vector<Tensor<2,1> >    &jacobians,
                                         const bool            compute_jacobians,
@@ -139,7 +140,7 @@ void FELinearMapping<1>::fill_fe_values (const DoFHandler<1>::cell_iterator &cel
 #if deal_II_dimension == 2
 
 template <>
-FELinearMapping<2>::FELinearMapping (const unsigned int dofs_per_vertex,
+FEQ1Mapping<2>::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,
@@ -158,7 +159,7 @@ FELinearMapping<2>::FELinearMapping (const unsigned int dofs_per_vertex,
 template <>
 inline
 double
-FELinearMapping<2>::shape_value_transform (const unsigned int i,
+FEQ1Mapping<2>::shape_value_transform (const unsigned int i,
                                           const Point<2>& p) const
 {
   Assert((i<4), ExcInvalidIndex(i));
@@ -177,7 +178,7 @@ FELinearMapping<2>::shape_value_transform (const unsigned int i,
 template <>
 inline
 Tensor<1,2>
-FELinearMapping<2>::shape_grad_transform (const unsigned int i,
+FEQ1Mapping<2>::shape_grad_transform (const unsigned int i,
                                          const Point<2>& p) const
 {
   Assert((i<4), ExcInvalidIndex(i));
@@ -194,7 +195,7 @@ FELinearMapping<2>::shape_grad_transform (const unsigned int i,
 
 
 template <>
-void FELinearMapping<2>::get_face_jacobians (const DoFHandler<2>::face_iterator &face,
+void FEQ1Mapping<2>::get_face_jacobians (const DoFHandler<2>::face_iterator &face,
                                             const vector<Point<1> > &unit_points,
                                             vector<double> &face_jacobians) const {
                                   // more or less copied from the linear
@@ -215,7 +216,7 @@ void FELinearMapping<2>::get_face_jacobians (const DoFHandler<2>::face_iterator
 
 
 template <>
-void FELinearMapping<2>::get_subface_jacobians (const DoFHandler<2>::face_iterator &face,
+void FEQ1Mapping<2>::get_subface_jacobians (const DoFHandler<2>::face_iterator &face,
                                                const unsigned int           ,
                                                const vector<Point<1> > &unit_points,
                                                vector<double> &face_jacobians) const {
@@ -239,7 +240,7 @@ void FELinearMapping<2>::get_subface_jacobians (const DoFHandler<2>::face_iterat
 
 
 template <>
-void FELinearMapping<2>::get_normal_vectors (const DoFHandler<2>::cell_iterator &cell,
+void FEQ1Mapping<2>::get_normal_vectors (const DoFHandler<2>::cell_iterator &cell,
                                             const unsigned int       face_no,
                                             const vector<Point<1> > &unit_points,
                                             vector<Point<2> > &normal_vectors) const {
@@ -270,7 +271,7 @@ void FELinearMapping<2>::get_normal_vectors (const DoFHandler<2>::cell_iterator
 
 
 template <>
-void FELinearMapping<2>::get_normal_vectors (const DoFHandler<2>::cell_iterator &cell,
+void FEQ1Mapping<2>::get_normal_vectors (const DoFHandler<2>::cell_iterator &cell,
                                             const unsigned int       face_no,
                                             const unsigned int,
                                             const vector<Point<1> > &unit_points,
@@ -311,7 +312,7 @@ void FELinearMapping<2>::get_normal_vectors (const DoFHandler<2>::cell_iterator
 #if deal_II_dimension == 3
 
 template <>
-FELinearMapping<3>::FELinearMapping (const unsigned int dofs_per_vertex,
+FEQ1Mapping<3>::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,
@@ -329,7 +330,7 @@ FELinearMapping<3>::FELinearMapping (const unsigned int dofs_per_vertex,
 template <>
 inline
 double
-FELinearMapping<3>::shape_value_transform (const unsigned int i,
+FEQ1Mapping<3>::shape_value_transform (const unsigned int i,
                                           const Point<3>& p) const
 {
   Assert((i<8), ExcInvalidIndex(i));
@@ -352,7 +353,7 @@ FELinearMapping<3>::shape_value_transform (const unsigned int i,
 template <>
 inline
 Tensor<1,3>
-FELinearMapping<3>::shape_grad_transform (const unsigned int i,
+FEQ1Mapping<3>::shape_grad_transform (const unsigned int i,
                                          const Point<3>& p) const
 {
   Assert((i<8), ExcInvalidIndex(i));
@@ -389,7 +390,7 @@ FELinearMapping<3>::shape_grad_transform (const unsigned int i,
 
 
 template <>
-void FELinearMapping<3>::get_face_jacobians (const DoFHandler<3>::face_iterator &face,
+void FEQ1Mapping<3>::get_face_jacobians (const DoFHandler<3>::face_iterator &face,
                                             const vector<Point<2> > &unit_points,
                                             vector<double> &face_jacobians) const {
   Assert (unit_points.size() == face_jacobians.size(),
@@ -461,7 +462,7 @@ void FELinearMapping<3>::get_face_jacobians (const DoFHandler<3>::face_iterator
 
 
 template <>
-void FELinearMapping<3>::get_subface_jacobians (const DoFHandler<3>::face_iterator &/*face*/,
+void FEQ1Mapping<3>::get_subface_jacobians (const DoFHandler<3>::face_iterator &/*face*/,
                                                const unsigned int           ,
                                                const vector<Point<2> > &unit_points,
                                                vector<double> &face_jacobians) const {
@@ -472,7 +473,7 @@ void FELinearMapping<3>::get_subface_jacobians (const DoFHandler<3>::face_iterat
 
 
 template <>
-void FELinearMapping<3>::get_normal_vectors (const DoFHandler<3>::cell_iterator &cell,
+void FEQ1Mapping<3>::get_normal_vectors (const DoFHandler<3>::cell_iterator &cell,
                                             const unsigned int       face_no,
                                             const vector<Point<2> > &unit_points,
                                             vector<Point<3> > &normal_vectors) const {
@@ -527,7 +528,7 @@ void FELinearMapping<3>::get_normal_vectors (const DoFHandler<3>::cell_iterator
 
 
 template <>
-void FELinearMapping<3>::get_normal_vectors (const DoFHandler<3>::cell_iterator &/*cell*/,
+void FEQ1Mapping<3>::get_normal_vectors (const DoFHandler<3>::cell_iterator &/*cell*/,
                                             const unsigned int       /*face_no*/,
                                             const unsigned int,
                                             const vector<Point<2> > &unit_points,
@@ -546,7 +547,7 @@ void FELinearMapping<3>::get_normal_vectors (const DoFHandler<3>::cell_iterator
 
 
 template <int dim>
-void FELinearMapping<dim>::fill_fe_values (const DoFHandler<dim>::cell_iterator &cell,
+void FEQ1Mapping<dim>::fill_fe_values (const DoFHandler<dim>::cell_iterator &cell,
                                           const vector<Point<dim> >            &unit_points,
                                           vector<Tensor<2,dim> >               &jacobians,
                                           const bool              compute_jacobians,
@@ -724,4 +725,4 @@ void FELinearMapping<dim>::fill_fe_values (const DoFHandler<dim>::cell_iterator
 
 /*------------------------------- Explicit Instantiations -------------*/
 
-template class FELinearMapping<deal_II_dimension>;
+template class FEQ1Mapping<deal_II_dimension>;
similarity index 99%
rename from deal.II/deal.II/source/fe/fe_linear_mapping.jacobians.cc
rename to deal.II/deal.II/source/fe/q1_mapping.jacobians.cc
index daa7dafe01f91409eabd1619fa3654ca046ef947..c82d50415dc8d07aa864e36f97eb72f5c7bb2bd4 100644 (file)
@@ -1,8 +1,9 @@
 /* $Id$ */
 /* Copyright W. Bangerth, University of Heidelberg, 1998 */
 
+// moved from file fe_linear_mapping_jacobians.cc
 
-#include <fe/fe_linear_mapping.h>
+#include <fe/q1_mapping.h>
 #include <grid/tria_iterator.h>
 #include <grid/dof_accessor.h>
 
@@ -11,7 +12,7 @@
 
 
 /**
- * This file has been singled out from fe_linear_mapping.cc because the computation
+ * This file has been singled out from q1_mapping.cc because the computation
  * of the 3d matrices is so extremely large that it can't be done with
  * optimization switched on. On the other hand, this also is not necessary,
  * because Maple outputs fairly good optimized code already. Singling out this file
@@ -24,7 +25,7 @@
 #if deal_II_dimension == 1
 
 template <>
-void FELinearMapping<1>::compute_jacobian_matrices (const DoFHandler<1>::cell_iterator &cell,
+void FEQ1Mapping<1>::compute_jacobian_matrices (const DoFHandler<1>::cell_iterator &cell,
                                                    const vector<Point<1> > &unit_points,
                                                    vector<Tensor<2,1> >    &jacobians) 
 {
@@ -40,7 +41,7 @@ void FELinearMapping<1>::compute_jacobian_matrices (const DoFHandler<1>::cell_it
 
 
 template <>
-void FELinearMapping<1>::compute_jacobian_gradients (const DoFHandler<1>::cell_iterator &,
+void FEQ1Mapping<1>::compute_jacobian_gradients (const DoFHandler<1>::cell_iterator &,
                                                     const vector<Point<1> > &unit_points,
                                                     vector<Tensor<3,1> >    &jacobians_grad) 
 {
@@ -62,7 +63,7 @@ void FELinearMapping<1>::compute_jacobian_gradients (const DoFHandler<1>::cell_i
 #if deal_II_dimension == 2
 
 template <>
-void FELinearMapping<2>::compute_jacobian_matrices (const DoFHandler<2>::cell_iterator &cell,
+void FEQ1Mapping<2>::compute_jacobian_matrices (const DoFHandler<2>::cell_iterator &cell,
                                                    const vector<Point<2> > &unit_points,
                                                    vector<Tensor<2,2> >    &jacobians) 
 {
@@ -115,7 +116,7 @@ void FELinearMapping<2>::compute_jacobian_matrices (const DoFHandler<2>::cell_it
 
 
 template <>
-void FELinearMapping<2>::compute_jacobian_gradients (const DoFHandler<2>::cell_iterator &cell,
+void FEQ1Mapping<2>::compute_jacobian_gradients (const DoFHandler<2>::cell_iterator &cell,
                                                     const vector<Point<2> > &unit_points,
                                                     vector<Tensor<3,2> >    &jacobians_grad) 
 {
@@ -199,7 +200,7 @@ void FELinearMapping<2>::compute_jacobian_gradients (const DoFHandler<2>::cell_i
 #if deal_II_dimension == 3
 
 template <>
-void FELinearMapping<3>::compute_jacobian_matrices (const DoFHandler<3>::cell_iterator &cell,
+void FEQ1Mapping<3>::compute_jacobian_matrices (const DoFHandler<3>::cell_iterator &cell,
                                                    const vector<Point<3> > &unit_points,
                                                    vector<Tensor<2,3> >    &jacobians) 
 {
@@ -1336,7 +1337,7 @@ void FELinearMapping<3>::compute_jacobian_matrices (const DoFHandler<3>::cell_it
 
 
 template <>
-void FELinearMapping<3>::compute_jacobian_gradients (const DoFHandler<3>::cell_iterator &cell,
+void FEQ1Mapping<3>::compute_jacobian_gradients (const DoFHandler<3>::cell_iterator &cell,
                                                     const vector<Point<3> > &unit_points,
                                                     vector<Tensor<3,3> >    &jacobians_grad) 
 {

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.