]> https://gitweb.dealii.org/ - dealii-svn.git/commitdiff
Use Table<2,...> instead of vector2d<...>.
authorwolf <wolf@0785d39b-7218-0410-832d-ea1e28bc413d>
Tue, 3 Sep 2002 15:35:45 +0000 (15:35 +0000)
committerwolf <wolf@0785d39b-7218-0410-832d-ea1e28bc413d>
Tue, 3 Sep 2002 15:35:45 +0000 (15:35 +0000)
git-svn-id: https://svn.dealii.org/trunk@6352 0785d39b-7218-0410-832d-ea1e28bc413d

deal.II/deal.II/include/fe/fe_dgp.h
deal.II/deal.II/include/fe/fe_dgq.h
deal.II/deal.II/include/fe/fe_nedelec.h
deal.II/deal.II/include/fe/fe_q.h
deal.II/deal.II/include/fe/fe_values.h
deal.II/deal.II/source/dofs/dof_tools.cc
deal.II/deal.II/source/fe/fe.cc
deal.II/deal.II/source/fe/fe_dgq.cc
deal.II/deal.II/source/multigrid/mg_dof_tools.cc

index 616adfc5f775da907a52b5910550d00847a1e10c..3c4973df72bd74e6a7f61415e981e882493407d2 100644 (file)
@@ -406,7 +406,7 @@ class FE_DGP : public FiniteElement<dim>
                                          * them over when visiting a
                                          * concrete cell.
                                          */
-       vector2d<double> shape_values;
+       Table<2,double> shape_values;
        
                                         /**
                                          * Array with shape function
@@ -426,7 +426,7 @@ class FE_DGP : public FiniteElement<dim>
                                          * multiplication) when
                                          * visiting an actual cell.
                                          */                                  
-       vector2d<Tensor<1,dim> > shape_gradients;
+       Table<2,Tensor<1,dim> > shape_gradients;
     };
     
                                     /**
index ca2f84762836537d25cb7553369340275a5c1ba4..fce607f6cab9ed889a47ad3ffd4e7b2c3dbb315a 100644 (file)
@@ -434,7 +434,7 @@ class FE_DGQ : public FiniteElement<dim>
                                          * them over when visiting a
                                          * concrete cell.
                                          */
-       vector2d<double> shape_values;
+       Table<2,double> shape_values;
        
                                         /**
                                          * Array with shape function
@@ -454,7 +454,7 @@ class FE_DGQ : public FiniteElement<dim>
                                          * multiplication) when
                                          * visiting an actual cell.
                                          */                                  
-       vector2d<Tensor<1,dim> > shape_gradients;
+       Table<2,Tensor<1,dim> > shape_gradients;
     };
     
                                     /**
index 8977a909cffc76f818970a6c9e43d02bc6ade529..a637ae39a9ee27b260bcb0925d7229da23454609 100644 (file)
@@ -437,7 +437,7 @@ class FE_Nedelec : public FiniteElement<dim>
                                          * multiplication with the
                                          * Jacobian of the mapping.
                                          */
-       vector2d<Tensor<1,dim> > shape_values;
+       Table<2,Tensor<1,dim> > shape_values;
 
                                         /**
                                          * Array with shape function
@@ -457,7 +457,7 @@ class FE_Nedelec : public FiniteElement<dim>
                                          * multiplication) when
                                          * visiting an actual cell.
                                          */
-       vector2d<Tensor<2,dim> > shape_gradients;
+       Table<2,Tensor<2,dim> > shape_gradients;
     };
     
                                     /**
index cb76726af3b0e5e0bef8f6893d6f7380e635a5ac..c70c0fb9eded705b0467be2b14ba4b3fd97c6146 100644 (file)
@@ -779,7 +779,7 @@ class FE_Q : public FiniteElement<dim>
                                          * them over when visiting a
                                          * concrete cell.
                                          */
-       vector2d<double> shape_values;
+       Table<2,double> shape_values;
 
                                         /**
                                          * Array with shape function
@@ -799,7 +799,7 @@ class FE_Q : public FiniteElement<dim>
                                          * multiplication) when
                                          * visiting an actual cell.
                                          */      
-       vector2d<Tensor<1,dim> > shape_gradients;
+       Table<2,Tensor<1,dim> > shape_gradients;
     };
     
                                     /**
index ed6cfed2f81c59b4f07803c79a78f9f89ed39259..91874b809741dc8fda1d272e7a38b33cd1872c6e 100644 (file)
@@ -20,7 +20,7 @@
 #include <base/point.h>
 #include <base/tensor.h>
 #include <base/quadrature.h>
-#include <base/vector2d.h>
+#include <base/table.h>
 #include <grid/tria.h>
 #include <grid/tria_iterator.h>
 #include <dofs/dof_handler.h>
@@ -94,7 +94,7 @@ class FEValuesData
                                      * thus have a row in the array
                                      * presently under discussion.
                                      */
-    typedef vector2d<double> ShapeVector;
+    typedef Table<2,double> ShapeVector;
 
                                     /**
                                      * Storage type for
@@ -102,13 +102,13 @@ class FEValuesData
                                      * is the same as for the
                                      * @ref{ShapeVector} data type.
                                      */
-    typedef vector2d<Tensor<1,dim> > GradientVector;
+    typedef Table<2,Tensor<1,dim> > GradientVector;
 
                                     /**
                                      * Likewise for second order
                                      * derivatives.
                                      */
-    typedef vector2d<Tensor<2,dim> > GradGradVector;
+    typedef Table<2,Tensor<2,dim> > GradGradVector;
     
                                     /**
                                      * Store the values of the shape
index 8ef232d15d513e4c7bc17396558a3b87c3a98909..9c88dfd678a72ced5bc532d24cca8686f61f733d 100644 (file)
@@ -475,14 +475,14 @@ DoFTools::make_flux_sparsity_pattern (const DoFHandler<dim> &dof,
   const unsigned int total_dofs = fe.dofs_per_cell;
   std::vector<unsigned int> dofs_on_this_cell(total_dofs);
   std::vector<unsigned int> dofs_on_other_cell(total_dofs);
-  vector2d<bool> support_on_face(total_dofs, GeometryInfo<dim>::faces_per_cell);
+  Table<2,bool> support_on_face(total_dofs, GeometryInfo<dim>::faces_per_cell);
   
   typename DoFHandler<dim>::active_cell_iterator cell = dof.begin_active(),
                                                 endc = dof.end();
 
 
-  vector2d<char> int_dof_mask(total_dofs, total_dofs);
-  vector2d<char> flux_dof_mask(total_dofs, total_dofs);
+  Table<2,char> int_dof_mask(total_dofs, total_dofs);
+  Table<2,char> flux_dof_mask(total_dofs, total_dofs);
 
   for (unsigned int i=0; i<total_dofs; ++i)
     {
index bb1f49f1f004410ef808e873446a77dbdaa25489..6002b08e73bdf70dbaad46b0e13641ebcb564783 100644 (file)
@@ -433,7 +433,7 @@ compute_2nd (const Mapping<dim>                   &mapping,
                                   // quotients of gradients in each
                                   // direction (first index) and at
                                   // all q-points (second index)
-  vector2d<Tensor<1,dim> >    diff_quot (dim, n_q_points);
+  Table<2,Tensor<1,dim> >    diff_quot (dim, n_q_points);
   std::vector<Tensor<1,dim> > diff_quot2 (n_q_points);
 
                                   // for all shape functions at all
index a15d65a7536197c475e186e4c7d97674a513a412..a638f981b0e5dc408602fa604d9aa4d9b85d3b11 100644 (file)
@@ -88,7 +88,7 @@ FE_DGQ<dim>::FE_DGQ (const unsigned int degree)
   else
                                     // matrix undefined, set size to zero
     for (unsigned int i=0;i<GeometryInfo<dim>::children_per_cell;++i)
-      this->prolongation[i].reinit(0);
+      this->prolongation[i].reinit(0, 0);
 
                                   // same as above: copy over matrix
                                   // from predefined values and
@@ -134,7 +134,7 @@ FE_DGQ<dim>::FE_DGQ (const unsigned int degree)
   else
                                     // matrix undefined, set size to zero
     for (unsigned int i=0;i<GeometryInfo<dim>::children_per_cell;++i)
-      this->restriction[i].reinit(0);
+      this->restriction[i].reinit(0, 0);
 
   
                                   // finally fill in support points
index d63d3b7ae74ff7f3ae7528994f4a6743cfa74b69..1886960bb5e4ba5d9d92a09a61898f9031b99873 100644 (file)
@@ -176,7 +176,7 @@ MGTools::make_flux_sparsity_pattern_edge (const MGDoFHandler<dim> &dof,
 
 
 
-//TODO: Replace FullMatrix by vector2d<bool>
+//TODO: Replace FullMatrix by Table<2,bool>
 template<int dim, class SparsityPattern>
 void
 MGTools::make_flux_sparsity_pattern (const MGDoFHandler<dim> &dof,

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.