From: kanschat Date: Sun, 12 Aug 2012 21:07:00 +0000 (+0000) Subject: Clarify documentation, no global dof indices found X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=2795b58751f7930bc21b03f3433adfb8c05ca3fa;p=dealii-svn.git Clarify documentation, no global dof indices found git-svn-id: https://svn.dealii.org/branches/branch_bigger_global_dof_indices_3@25910 0785d39b-7218-0410-832d-ea1e28bc413d --- diff --git a/deal.II/include/deal.II/fe/fe_tools.h b/deal.II/include/deal.II/fe/fe_tools.h index a676aa304f..b0906ff001 100644 --- a/deal.II/include/deal.II/fe/fe_tools.h +++ b/deal.II/include/deal.II/fe/fe_tools.h @@ -167,12 +167,22 @@ namespace FETools * 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 + * fe has dofs per + * cell. The indices reference the + * local dofs on the cell, not the + * global dofs. + * + * @param start_indice: + * 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 @@ -755,13 +765,14 @@ namespace FETools */ template void - compute_projection_from_face_quadrature_points_matrix (const FiniteElement &fe, - const Quadrature &lhs_quadrature, - const Quadrature &rhs_quadrature, - const typename DoFHandler::active_cell_iterator & cell, - unsigned int face, - FullMatrix &X); - + compute_projection_from_face_quadrature_points_matrix ( + const FiniteElement &fe, + const Quadrature &lhs_quadrature, + const Quadrature &rhs_quadrature, + const typename DoFHandler::active_cell_iterator & cell, + unsigned int face, + FullMatrix &X); + //@}