};
+
template <>
FEQ2<1>::FEQ2 (const int) :
FEQ1Mapping<1> (0, 3, 0, 0, 1,
};
+
template <>
void FEQ2<1>::initialize_matrices ()
{
};
+
template <>
double
FEQ2<1>::shape_value(const unsigned int i,
};
+
template <>
Tensor<1,1>
FEQ2<1>::shape_grad(const unsigned int i,
};
+
template <>
Tensor<2,1>
FEQ2<1>::shape_grad_grad (const unsigned int i,
};
+
template <>
-void FEQ2<1>::get_unit_support_points (vector<Point<1> > &unit_points) const {
+void FEQ2<1>::get_unit_support_points (vector<Point<1> > &unit_points) const
+{
FiniteElement<1>::get_unit_support_points (unit_points);
};
+
template <>
void FEQ2<1>::get_support_points (const DoFHandler<1>::cell_iterator &cell,
- vector<Point<1> > &support_points) const {
+ vector<Point<1> > &support_points) const
+{
FiniteElement<1>::get_support_points (cell, support_points);
};
+
template <>
void FEQ2<1>::get_face_support_points (const DoFHandler<1>::face_iterator &,
- vector<Point<1> > &) const {
+ vector<Point<1> > &) const
+{
Assert (false, ExcInternalError());
};
+
template <>
void FEQ2<1>::get_local_mass_matrix (const DoFHandler<1>::cell_iterator &cell,
- FullMatrix<double> &local_mass_matrix) const {
+ FullMatrix<double> &local_mass_matrix) const
+{
Assert (local_mass_matrix.n() == dofs_per_cell,
ExcWrongFieldDimension(local_mass_matrix.n(),dofs_per_cell));
Assert (local_mass_matrix.m() == dofs_per_cell,
};
+
template <>
FEQ2<2>::FEQ2 (const int) :
FEQ1Mapping<2> (0, 0, 9, 0, 1,
};
+
template <>
void FEQ2<2>::initialize_matrices ()
{
};
+
template <>
double
FEQ2<2>::shape_value (const unsigned int i,
- const Point<2> &p) const
+ const Point<2> &p) const
{
Assert (i<dofs_per_cell, ExcIndexRange(i, 0, dofs_per_cell));
};
+
template <>
Tensor<1,2>
FEQ2<2>::shape_grad (const unsigned int i,
- const Point<2> &p) const
+ const Point<2> &p) const
{
Assert (i<dofs_per_cell, ExcIndexRange(i, 0, dofs_per_cell));
};
+
template <>
Tensor<2,2>
FEQ2<2>::shape_grad_grad (const unsigned int i,
- const Point<2> &p) const
+ const Point<2> &p) const
{
Assert (i<dofs_per_cell, ExcIndexRange(i, 0, dofs_per_cell));
};
+
template <>
void FEQ2<2>::get_local_mass_matrix (const DoFHandler<2>::cell_iterator &cell,
- FullMatrix<double> &local_mass_matrix) const {
+ FullMatrix<double> &local_mass_matrix) const
+{
Assert (local_mass_matrix.n() == dofs_per_cell,
ExcWrongFieldDimension(local_mass_matrix.n(),dofs_per_cell));
Assert (local_mass_matrix.m() == dofs_per_cell,
};
+
template <>
-void FEQ2<2>::get_unit_support_points (vector<Point<2> > &unit_points) const {
+void FEQ2<2>::get_unit_support_points (vector<Point<2> > &unit_points) const
+{
Assert (unit_points.size() == dofs_per_cell,
ExcWrongFieldDimension (unit_points.size(), dofs_per_cell));
};
+
template <>
void FEQ2<2>::get_support_points (const DoFHandler<2>::cell_iterator &cell,
- vector<Point<2> > &support_points) const {
+ vector<Point<2> > &support_points) const
+{
Assert (support_points.size() == dofs_per_cell,
ExcWrongFieldDimension (support_points.size(), dofs_per_cell));
};
+
template <>
void FEQ2<2>::get_face_support_points (const DoFHandler<2>::face_iterator &face,
- vector<Point<2> > &support_points) const {
+ vector<Point<2> > &support_points) const
+{
Assert (support_points.size() == dofs_per_face,
ExcWrongFieldDimension (support_points.size(), dofs_per_face));
};
+
template <>
FEQ2<3>::FEQ2 (const int) :
FEQ1Mapping<3> (0, 0, 0, 27, 1,
};
+
template <>
void FEQ2<3>::initialize_matrices ()
{
};
+
template <>
double
FEQ2<3>::shape_value (const unsigned int i,
- const Point<3> &p) const
+ const Point<3> &p) const
{
Assert (i<dofs_per_cell, ExcIndexRange(i, 0, dofs_per_cell));
};
+
template <>
Tensor<1,3>
FEQ2<3>::shape_grad (const unsigned int i,
- const Point<3> &p) const
+ const Point<3> &p) const
{
Assert (i<dofs_per_cell, ExcIndexRange(i, 0, dofs_per_cell));
};
+
template <>
Tensor<2,3>
FEQ2<3>::shape_grad_grad (const unsigned int i,
- const Point<3> &p) const
+ const Point<3> &p) const
{
Assert (i<dofs_per_cell, ExcIndexRange(i, 0, dofs_per_cell));
};
+
template <>
void FEQ2<3>::get_local_mass_matrix (const DoFHandler<3>::cell_iterator &,
- FullMatrix<double> &local_mass_matrix) const {
+ FullMatrix<double> &local_mass_matrix) const
+{
Assert (local_mass_matrix.n() == dofs_per_cell,
ExcWrongFieldDimension(local_mass_matrix.n(),dofs_per_cell));
Assert (local_mass_matrix.m() == dofs_per_cell,
};
+
template <>
-void FEQ2<3>::get_unit_support_points (vector<Point<3> > &unit_points) const {
+void FEQ2<3>::get_unit_support_points (vector<Point<3> > &unit_points) const
+{
Assert (unit_points.size() == dofs_per_cell,
ExcWrongFieldDimension (unit_points.size(), dofs_per_cell));
};
+
template <>
void FEQ2<3>::get_support_points (const DoFHandler<3>::cell_iterator &cell,
- vector<Point<3> > &support_points) const {
+ vector<Point<3> > &support_points) const
+{
Assert (support_points.size() == dofs_per_cell,
ExcWrongFieldDimension (support_points.size(), dofs_per_cell));
};
+
template <>
void FEQ2<3>::get_face_support_points (const DoFHandler<3>::face_iterator &face,
- vector<Point<3> > &support_points) const {
+ vector<Point<3> > &support_points) const
+{
Assert (support_points.size() == dofs_per_face,
ExcWrongFieldDimension (support_points.size(), dofs_per_face));