* them over when visiting a
* concrete cell.
*/
- vector2d<double> shape_values;
+ Table<2,double> shape_values;
/**
* Array with shape function
* multiplication) when
* visiting an actual cell.
*/
- vector2d<Tensor<1,dim> > shape_gradients;
+ Table<2,Tensor<1,dim> > shape_gradients;
};
/**
* them over when visiting a
* concrete cell.
*/
- vector2d<double> shape_values;
+ Table<2,double> shape_values;
/**
* Array with shape function
* multiplication) when
* visiting an actual cell.
*/
- vector2d<Tensor<1,dim> > shape_gradients;
+ Table<2,Tensor<1,dim> > shape_gradients;
};
/**
* multiplication with the
* Jacobian of the mapping.
*/
- vector2d<Tensor<1,dim> > shape_values;
+ Table<2,Tensor<1,dim> > shape_values;
/**
* Array with shape function
* multiplication) when
* visiting an actual cell.
*/
- vector2d<Tensor<2,dim> > shape_gradients;
+ Table<2,Tensor<2,dim> > shape_gradients;
};
/**
* them over when visiting a
* concrete cell.
*/
- vector2d<double> shape_values;
+ Table<2,double> shape_values;
/**
* Array with shape function
* multiplication) when
* visiting an actual cell.
*/
- vector2d<Tensor<1,dim> > shape_gradients;
+ Table<2,Tensor<1,dim> > shape_gradients;
};
/**
#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>
* thus have a row in the array
* presently under discussion.
*/
- typedef vector2d<double> ShapeVector;
+ typedef Table<2,double> ShapeVector;
/**
* Storage type for
* 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
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)
{
// 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
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
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
-//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,