* class. Called from the
* constructor.
*/
- void initialize_unit_support_points ();
+ void initialize_support_points (const unsigned int rt_degree);
/**
* Initialize the
* class. Called from the
* constructor.
*/
- void initialize_unit_face_support_points ();
-
+ void initialize_face_support_points ();
/**
* Given a set of flags indicating
* what quantities are requested
get_ria_vector (const unsigned int degree);
/**
* Initialize the
- * FiniteElement<dim>::unit_support_points
- * and FiniteElement<dim>::unit_face_support_points
+ * FiniteElement<dim>::generalized_support_points
+ * and FiniteElement<dim>::generalized_face_support_points
* fields. Called from the
* constructor.
*/
- void initialize_unit_support_points (const unsigned int degree);
-
- /**
- * Initialize the
- * #inverse_node_matrix
- * field. Called from the
- * constructor.
- */
- void initialize_node_matrix ();
+ void initialize_support_points (const unsigned int rt_degree);
};
#ifndef DOXYGEN
template <>
-void FE_RaviartThomas<1>::initialize_unit_face_support_points ();
+void FE_RaviartThomas<1>::initialize_face_support_points ();
template <>
std::vector<unsigned int> FE_RaviartThomas<1>::get_dpo_vector (const unsigned int);
// finally fill in support points
// on cell and face
- initialize_unit_support_points ();
- initialize_unit_face_support_points ();
+ initialize_support_points (rt_order);
+ initialize_face_support_points ();
// then make
// system_to_component_table
#endif
+//TODO: Unit support points should go away according to new definition.
+
template <int dim>
void
-FE_RaviartThomas<dim>::initialize_unit_support_points ()
+FE_RaviartThomas<dim>::initialize_support_points (const unsigned int)
{
+// unsigned int n_face_points = (dim>1) ? 1 : 0;
+// // compute (deg+1)^(dim-1)
+// for (unsigned int d=1;d<dim;++d)
+// n_face_points *= deg+1;
+
+// this->unit_generalized_support_points.resize (this->dofs_per_cell);
+// this->generalized_face_support_points.resize (this->dofs_per_face);
+
+
this->unit_support_points.resize (this->dofs_per_cell);
switch (dim)
{
#if deal_II_dimension == 1
template <>
-void FE_RaviartThomas<1>::initialize_unit_face_support_points ()
+void FE_RaviartThomas<1>::initialize_face_support_points ()
{
// no faces in 1d, so nothing to do
}
template <int dim>
-void FE_RaviartThomas<dim>::initialize_unit_face_support_points ()
+void FE_RaviartThomas<dim>::initialize_face_support_points ()
{
this->unit_face_support_points.resize (this->dofs_per_face);
// Set up the generalized support
// points
- initialize_unit_support_points (deg);
+ initialize_support_points (deg);
//Now compute the inverse node
//matrix, generating the correct
template <int dim>
void
-FE_RaviartThomasNodal<dim>::initialize_unit_support_points (const unsigned int deg)
+FE_RaviartThomasNodal<dim>::initialize_support_points (const unsigned int deg)
{
this->generalized_support_points.resize (this->dofs_per_cell);
this->generalized_face_support_points.resize (this->dofs_per_face);
}
-template <int dim>
-void
-FE_RaviartThomasNodal<dim>::initialize_node_matrix ()
-{
-}
-
-
-
template class FE_RaviartThomasNodal<deal_II_dimension>;