]> https://gitweb.dealii.org/ - dealii-svn.git/commitdiff
Clarify documentation, no global dof indices found
authorkanschat <kanschat@0785d39b-7218-0410-832d-ea1e28bc413d>
Sun, 12 Aug 2012 21:07:00 +0000 (21:07 +0000)
committerkanschat <kanschat@0785d39b-7218-0410-832d-ea1e28bc413d>
Sun, 12 Aug 2012 21:07:00 +0000 (21:07 +0000)
git-svn-id: https://svn.dealii.org/branches/branch_bigger_global_dof_indices_3@25910 0785d39b-7218-0410-832d-ea1e28bc413d

deal.II/include/deal.II/fe/fe_tools.h

index a676aa304f1c59c09af8f8e0750e57e9bc652c36..b0906ff001613ad3d01397b88a09c17d887585d6 100644 (file)
@@ -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
+                                    * <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
@@ -755,13 +765,14 @@ namespace FETools
                                     */
   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);
+  
 
 
                                    //@}

In the beginning the Universe was created. This has made a lot of people very angry and has been widely regarded as a bad move.

Douglas Adams


Typeset in Trocchi and Trocchi Bold Sans Serif.