From: wolf Date: Tue, 3 Sep 2002 15:35:45 +0000 (+0000) Subject: Use Table<2,...> instead of vector2d<...>. X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=5bffdf9ed9740ffc59322d32e0824b9f55ae4050;p=dealii-svn.git Use Table<2,...> instead of vector2d<...>. git-svn-id: https://svn.dealii.org/trunk@6352 0785d39b-7218-0410-832d-ea1e28bc413d --- diff --git a/deal.II/deal.II/include/fe/fe_dgp.h b/deal.II/deal.II/include/fe/fe_dgp.h index 616adfc5f7..3c4973df72 100644 --- a/deal.II/deal.II/include/fe/fe_dgp.h +++ b/deal.II/deal.II/include/fe/fe_dgp.h @@ -406,7 +406,7 @@ class FE_DGP : public FiniteElement * them over when visiting a * concrete cell. */ - vector2d shape_values; + Table<2,double> shape_values; /** * Array with shape function @@ -426,7 +426,7 @@ class FE_DGP : public FiniteElement * multiplication) when * visiting an actual cell. */ - vector2d > shape_gradients; + Table<2,Tensor<1,dim> > shape_gradients; }; /** diff --git a/deal.II/deal.II/include/fe/fe_dgq.h b/deal.II/deal.II/include/fe/fe_dgq.h index ca2f847628..fce607f6ca 100644 --- a/deal.II/deal.II/include/fe/fe_dgq.h +++ b/deal.II/deal.II/include/fe/fe_dgq.h @@ -434,7 +434,7 @@ class FE_DGQ : public FiniteElement * them over when visiting a * concrete cell. */ - vector2d shape_values; + Table<2,double> shape_values; /** * Array with shape function @@ -454,7 +454,7 @@ class FE_DGQ : public FiniteElement * multiplication) when * visiting an actual cell. */ - vector2d > shape_gradients; + Table<2,Tensor<1,dim> > shape_gradients; }; /** diff --git a/deal.II/deal.II/include/fe/fe_nedelec.h b/deal.II/deal.II/include/fe/fe_nedelec.h index 8977a909cf..a637ae39a9 100644 --- a/deal.II/deal.II/include/fe/fe_nedelec.h +++ b/deal.II/deal.II/include/fe/fe_nedelec.h @@ -437,7 +437,7 @@ class FE_Nedelec : public FiniteElement * multiplication with the * Jacobian of the mapping. */ - vector2d > shape_values; + Table<2,Tensor<1,dim> > shape_values; /** * Array with shape function @@ -457,7 +457,7 @@ class FE_Nedelec : public FiniteElement * multiplication) when * visiting an actual cell. */ - vector2d > shape_gradients; + Table<2,Tensor<2,dim> > shape_gradients; }; /** diff --git a/deal.II/deal.II/include/fe/fe_q.h b/deal.II/deal.II/include/fe/fe_q.h index cb76726af3..c70c0fb9ed 100644 --- a/deal.II/deal.II/include/fe/fe_q.h +++ b/deal.II/deal.II/include/fe/fe_q.h @@ -779,7 +779,7 @@ class FE_Q : public FiniteElement * them over when visiting a * concrete cell. */ - vector2d shape_values; + Table<2,double> shape_values; /** * Array with shape function @@ -799,7 +799,7 @@ class FE_Q : public FiniteElement * multiplication) when * visiting an actual cell. */ - vector2d > shape_gradients; + Table<2,Tensor<1,dim> > shape_gradients; }; /** diff --git a/deal.II/deal.II/include/fe/fe_values.h b/deal.II/deal.II/include/fe/fe_values.h index ed6cfed2f8..91874b8097 100644 --- a/deal.II/deal.II/include/fe/fe_values.h +++ b/deal.II/deal.II/include/fe/fe_values.h @@ -20,7 +20,7 @@ #include #include #include -#include +#include #include #include #include @@ -94,7 +94,7 @@ class FEValuesData * thus have a row in the array * presently under discussion. */ - typedef vector2d 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 > GradientVector; + typedef Table<2,Tensor<1,dim> > GradientVector; /** * Likewise for second order * derivatives. */ - typedef vector2d > GradGradVector; + typedef Table<2,Tensor<2,dim> > GradGradVector; /** * Store the values of the shape diff --git a/deal.II/deal.II/source/dofs/dof_tools.cc b/deal.II/deal.II/source/dofs/dof_tools.cc index 8ef232d15d..9c88dfd678 100644 --- a/deal.II/deal.II/source/dofs/dof_tools.cc +++ b/deal.II/deal.II/source/dofs/dof_tools.cc @@ -475,14 +475,14 @@ DoFTools::make_flux_sparsity_pattern (const DoFHandler &dof, const unsigned int total_dofs = fe.dofs_per_cell; std::vector dofs_on_this_cell(total_dofs); std::vector dofs_on_other_cell(total_dofs); - vector2d support_on_face(total_dofs, GeometryInfo::faces_per_cell); + Table<2,bool> support_on_face(total_dofs, GeometryInfo::faces_per_cell); typename DoFHandler::active_cell_iterator cell = dof.begin_active(), endc = dof.end(); - vector2d int_dof_mask(total_dofs, total_dofs); - vector2d 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 &mapping, // quotients of gradients in each // direction (first index) and at // all q-points (second index) - vector2d > diff_quot (dim, n_q_points); + Table<2,Tensor<1,dim> > diff_quot (dim, n_q_points); std::vector > diff_quot2 (n_q_points); // for all shape functions at all diff --git a/deal.II/deal.II/source/fe/fe_dgq.cc b/deal.II/deal.II/source/fe/fe_dgq.cc index a15d65a753..a638f981b0 100644 --- a/deal.II/deal.II/source/fe/fe_dgq.cc +++ b/deal.II/deal.II/source/fe/fe_dgq.cc @@ -88,7 +88,7 @@ FE_DGQ::FE_DGQ (const unsigned int degree) else // matrix undefined, set size to zero for (unsigned int i=0;i::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::FE_DGQ (const unsigned int degree) else // matrix undefined, set size to zero for (unsigned int i=0;i::children_per_cell;++i) - this->restriction[i].reinit(0); + this->restriction[i].reinit(0, 0); // finally fill in support points diff --git a/deal.II/deal.II/source/multigrid/mg_dof_tools.cc b/deal.II/deal.II/source/multigrid/mg_dof_tools.cc index d63d3b7ae7..1886960bb5 100644 --- a/deal.II/deal.II/source/multigrid/mg_dof_tools.cc +++ b/deal.II/deal.II/source/multigrid/mg_dof_tools.cc @@ -176,7 +176,7 @@ MGTools::make_flux_sparsity_pattern_edge (const MGDoFHandler &dof, -//TODO: Replace FullMatrix by vector2d +//TODO: Replace FullMatrix by Table<2,bool> template void MGTools::make_flux_sparsity_pattern (const MGDoFHandler &dof,