bool
hp_constraints_are_implemented () const;
+ /**
+ * Return the matrix interpolating from the given finite element to the
+ * present one. Since the current finite element has no degrees of freedom, the
+ * interpolation matrix is necessarily empty.
+ */
+ virtual
+ void
+ get_interpolation_matrix (const FiniteElement<dim,spacedim> &source_fe,
+ FullMatrix<double> &interpolation_matrix) const;
+
/**
* Return the matrix interpolating from a face of of one element to the face
* of the neighboring element. The size of the matrix is then
}
+
+template <int dim, int spacedim>
+void
+FE_Nothing<dim,spacedim>::
+get_interpolation_matrix (const FiniteElement<dim,spacedim> &/*source_fe*/,
+ FullMatrix<double> &interpolation_matrix) const
+{
+ // Since this element has no dofs,
+ // the interpolation matrix is necessarily empty.
+ (void)interpolation_matrix;
+
+ Assert (interpolation_matrix.m() == 0,
+ ExcDimensionMismatch (interpolation_matrix.m(),
+ 0));
+ Assert (interpolation_matrix.n() == 0,
+ ExcDimensionMismatch (interpolation_matrix.n(),
+ 0));
+}
+
+
+
template <int dim, int spacedim>
void
FE_Nothing<dim,spacedim>::