* FETools::compute_node_matrix(). It relies on the existence of
* #generalized_support_points and implementation of interpolate()
* with VectorSlice argument.
+ * See the @ref GlossGeneralizedSupport "glossary entry on generalized support points"
+ * for more information.
*
* The piece of code in the constructor of a finite element
* responsible for this looks like
/**
* Return a support point vector
* for generalized interpolation.
+ *
+ * See the @ref GlossGeneralizedSupport "glossary entry on generalized support points"
+ * for more information.
*/
const std::vector<Point<dim> > &
get_generalized_support_points () const;
* vectors either from
* get_unit_support_points() or
* get_generalized_support_points().
+ *
+ * See the @ref GlossGeneralizedSupport "glossary entry on generalized support points"
+ * for more information.
*/
bool has_generalized_support_points () const;
* sufficient accuracy. The points needed are those of
* QGauss<sub>k+1</sub> on each face as well as QGauss<sub>k</sub> in
* the interior of the cell (or none for RT<sub>0</sub>).
+ * See the @ref GlossGeneralizedSupport "glossary entry on generalized support points"
+ * for more information.
*
*
* @author Oliver Kayser-Herold, 2006, based on previous work
* (#boundary_weights and
* #interior_weights). Called
* from the constructor.
+ *
+ * See the @ref GlossGeneralizedSupport "glossary entry on generalized support points"
+ * for more information.
*/
void initialize_support_points (const unsigned int rt_degree);
* and FiniteElement<dim>::generalized_face_support_points
* fields. Called from the
* constructor.
+ * See the @ref GlossGeneralizedSupport "glossary entry on generalized support points"
+ * for more information.
*/
void initialize_support_points (const unsigned int rt_degree);
/**
* class and fill the tables with
* @p interior_weights. Called
* from the constructor.
+ *
+ * See the @ref GlossGeneralizedSupport "glossary entry on generalized support points"
+ * for more information.
*/
void initialize_support_points (const unsigned int degree);
* #generalized_face_support_points
* when computing the
* integration.
+ *
+ * See the @ref GlossGeneralizedSupport "glossary entry on generalized support points"
+ * for more information.
*/
Table<2, double> boundary_weights;
* face support point and one
* column for each degree of
* freedom on the face.
+ *
+ * See the @ref GlossGeneralizedSupport "glossary entry on generalized support points"
+ * for more information.
*/
Table<2, double> boundary_weights;
/**
* and FiniteElement<dim>::generalized_face_support_points
* fields. Called from the
* constructor.
+ *
+ * See the @ref GlossGeneralizedSupport "glossary entry on generalized support points"
+ * for more information.
*/
void initialize_support_points (const unsigned int rt_degree);
};