* component in the local block
* vector.
*
- * The second vector is organized
- * such that there is a vector
- * for each base element
- * containing the start index for
- * each component served by this
- * base element.
+ * @param fe: The finite element
+ * used, typically an FESystem.
+ *
+ * @param renumbering: A vector
+ * with as many entries as
+ * <tt>fe</tt> has dofs per
+ * cell. The indices reference the
+ * local dofs on the cell, not the
+ * global dofs.
+ *
+ * @param <tt>start_indice</tt>:
+ * This vector is organized such
+ * that there is a vector for each
+ * base element containing the
+ * start index for each component
+ * served by this base element.
*
* While the first vector is
* checked to have the correct
*/
template <int dim, int spacedim>
void
- compute_projection_from_face_quadrature_points_matrix (const FiniteElement<dim, spacedim> &fe,
- const Quadrature<dim-1> &lhs_quadrature,
- const Quadrature<dim-1> &rhs_quadrature,
- const typename DoFHandler<dim, spacedim>::active_cell_iterator & cell,
- unsigned int face,
- FullMatrix<double> &X);
-
+ compute_projection_from_face_quadrature_points_matrix (
+ const FiniteElement<dim, spacedim> &fe,
+ const Quadrature<dim-1> &lhs_quadrature,
+ const Quadrature<dim-1> &rhs_quadrature,
+ const typename DoFHandler<dim, spacedim>::active_cell_iterator & cell,
+ unsigned int face,
+ FullMatrix<double> &X);
+
//@}