static const unsigned int n_shape_functions = GeometryInfo<dim>::vertices_per_cell;
};
+/*----------------------------------------------------------------------*/
+
+template<int dim>
+inline
+double
+MappingQ1<dim>::InternalData::shape (const unsigned int qpoint,
+ const unsigned int shape_nr) const
+{
+ Assert(qpoint*n_shape_functions + shape_nr < shape_values.size(),
+ ExcIndexRange(qpoint*n_shape_functions + shape_nr, 0,
+ shape_values.size()));
+ return shape_values [qpoint*n_shape_functions + shape_nr];
+}
+
+
+
+template <int dim>
+inline
+double &
+MappingQ1<dim>::InternalData::shape (const unsigned int qpoint,
+ const unsigned int shape_nr)
+{
+ Assert(qpoint*n_shape_functions + shape_nr < shape_values.size(),
+ ExcIndexRange(qpoint*n_shape_functions + shape_nr, 0,
+ shape_values.size()));
+ return shape_values [qpoint*n_shape_functions + shape_nr];
+}
+
+
+template <int dim>
+inline
+Tensor<1,dim>
+MappingQ1<dim>::InternalData::derivative (const unsigned int qpoint,
+ const unsigned int shape_nr) const
+{
+ Assert(qpoint*n_shape_functions + shape_nr < shape_derivatives.size(),
+ ExcIndexRange(qpoint*n_shape_functions + shape_nr, 0,
+ shape_derivatives.size()));
+ return shape_derivatives [qpoint*n_shape_functions + shape_nr];
+}
+
+
+
+template <int dim>
+inline
+Tensor<1,dim> &
+MappingQ1<dim>::InternalData::derivative (const unsigned int qpoint,
+ const unsigned int shape_nr)
+{
+ Assert(qpoint*n_shape_functions + shape_nr < shape_derivatives.size(),
+ ExcIndexRange(qpoint*n_shape_functions + shape_nr, 0,
+ shape_derivatives.size()));
+ return shape_derivatives [qpoint*n_shape_functions + shape_nr];
+}
+
+
+
+
/* -------------- declaration of explicit specializations ------------- */
#include <fe/fe.h>
#include <base/memory_consumption.h>
#include <fe/mapping.h>
-#include <fe/mapping_q1.h>
#include <fe/fe_values.h>
#include <base/quadrature.h>
#include <grid/tria.h>
#include <dofs/dof_accessor.h>
#include <fe/fe.h>
#include <fe/mapping.h>
-#include <fe/mapping_q1.h>
#include <fe/fe_dgp.h>
#include <fe/fe_values.h>
#include <dofs/dof_accessor.h>
#include <fe/fe.h>
#include <fe/mapping.h>
-#include <fe/mapping_q1.h>
#include <fe/fe_dgq.h>
#include <fe/fe_values.h>
#include <dofs/dof_accessor.h>
#include <fe/fe.h>
#include <fe/mapping.h>
-#include <fe/mapping_q1.h>
#include <fe/fe_q.h>
#include <fe/fe_values.h>
-template<int dim>
-double
-MappingQ1<dim>::InternalData::shape (const unsigned int qpoint,
- const unsigned int shape_nr) const
-{
- Assert(qpoint*n_shape_functions + shape_nr < shape_values.size(),
- ExcIndexRange(qpoint*n_shape_functions + shape_nr, 0,
- shape_values.size()));
- return shape_values [qpoint*n_shape_functions + shape_nr];
-}
-
-
-
-template <int dim>
-double &
-MappingQ1<dim>::InternalData::shape (const unsigned int qpoint,
- const unsigned int shape_nr)
-{
- Assert(qpoint*n_shape_functions + shape_nr < shape_values.size(),
- ExcIndexRange(qpoint*n_shape_functions + shape_nr, 0,
- shape_values.size()));
- return shape_values [qpoint*n_shape_functions + shape_nr];
-}
-
-
-template <int dim>
-Tensor<1,dim>
-MappingQ1<dim>::InternalData::derivative (const unsigned int qpoint,
- const unsigned int shape_nr) const
-{
- Assert(qpoint*n_shape_functions + shape_nr < shape_derivatives.size(),
- ExcIndexRange(qpoint*n_shape_functions + shape_nr, 0,
- shape_derivatives.size()));
- return shape_derivatives [qpoint*n_shape_functions + shape_nr];
-}
-
-
-
-template <int dim>
-Tensor<1,dim> &
-MappingQ1<dim>::InternalData::derivative (const unsigned int qpoint,
- const unsigned int shape_nr)
-{
- Assert(qpoint*n_shape_functions + shape_nr < shape_derivatives.size(),
- ExcIndexRange(qpoint*n_shape_functions + shape_nr, 0,
- shape_derivatives.size()));
- return shape_derivatives [qpoint*n_shape_functions + shape_nr];
-}
-
-
-
template <int dim>
unsigned int
MappingQ1<dim>::InternalData::memory_consumption () const