const FEValuesBase<dim> &fetest,
double factor = 1.)
{
- unsigned int fecomp = fe.get_fe().n_components();
const unsigned int n_dofs = fe.dofs_per_cell;
const unsigned int t_dofs = fetest.dofs_per_cell;
- AssertDimension(fecomp, dim);
+ AssertDimension(fe.get_fe().n_components(), dim);
AssertDimension(fetest.get_fe().n_components(), 1);
AssertDimension(M.m(), t_dofs);
AssertDimension(M.n(), n_dofs);
const FEValuesBase<dim> &fetest,
double factor = 1.)
{
- unsigned int fecomp = fetest.get_fe().n_components();
const unsigned int t_dofs = fetest.dofs_per_cell;
const unsigned int n_dofs = fe.dofs_per_cell;
- AssertDimension(fecomp, dim);
+ AssertDimension(fetest.get_fe().n_components(), dim);
AssertDimension(fe.get_fe().n_components(), 1);
AssertDimension(M.m(), t_dofs);
AssertDimension(M.n(), n_dofs);
const FEValuesBase<dim> &fetest,
double factor = 1.)
{
- unsigned int fecomp = fe.get_fe().n_components();
const unsigned int n_dofs = fe.dofs_per_cell;
const unsigned int t_dofs = fetest.dofs_per_cell;
- AssertDimension(fecomp, dim);
+ AssertDimension(fe.get_fe().n_components(), dim);
AssertDimension(fetest.get_fe().n_components(), 1);
AssertDimension(M.m(), t_dofs);
AssertDimension(M.n(), n_dofs);
const VectorSlice<const std::vector<std::vector<double> > > &data,
double factor = 1.)
{
- unsigned int fecomp = fe.get_fe().n_components();
const unsigned int t_dofs = fetest.dofs_per_cell;
- AssertDimension(fecomp, dim);
+ AssertDimension(fe.get_fe().n_components(), dim);
AssertDimension(fetest.get_fe().n_components(), 1);
AssertDimension(result.size(), t_dofs);
AssertVectorVectorDimension (data, dim, fe.n_quadrature_points);
double norm(const FEValuesBase<dim> &fe,
const VectorSlice<const std::vector<std::vector<Tensor<1,dim> > > > &Du)
{
- unsigned int fecomp = fe.get_fe().n_components();
-
- AssertDimension(fecomp, dim);
+ AssertDimension(fe.get_fe().n_components(), dim);
AssertVectorVectorDimension (Du, dim, fe.n_quadrature_points);
double result = 0;
const double factor = 1.)
{
const unsigned int n_dofs = fe.dofs_per_cell;
- const unsigned int fe_components = fe.get_fe().n_components();
const unsigned int n_components = input.size();
AssertDimension(result.size(), n_dofs);
- AssertDimension(input.size(), fe_components);
+ AssertDimension(input.size(), fe.get_fe().n_components());
for (unsigned int k=0; k<fe.n_quadrature_points; ++k)
for (unsigned int i=0; i<n_dofs; ++i)