]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Update documentation in a couple of places.
authorWolfgang Bangerth <bangerth@math.tamu.edu>
Tue, 3 Sep 2013 21:08:48 +0000 (21:08 +0000)
committerWolfgang Bangerth <bangerth@math.tamu.edu>
Tue, 3 Sep 2013 21:08:48 +0000 (21:08 +0000)
git-svn-id: https://svn.dealii.org/trunk@30578 0785d39b-7218-0410-832d-ea1e28bc413d

deal.II/include/deal.II/hp/dof_levels.h

index f307cc71727b232e869d1bed9f213da1ea64b239..0f34ab2d45251aba89eab088598ec3d8c0ead288 100644 (file)
@@ -23,6 +23,7 @@
 
 #include <vector>
 
+
 DEAL_II_NAMESPACE_OPEN
 
 namespace hp
@@ -61,25 +62,26 @@ namespace internal
     {
     private:
       /**
-       *  Indices specifying the finite
-       *  element of hp::FECollection to use
-       *  for the different cells on the current level. The
-       *  meaning what a cell is, is
-       *  dimension specific, therefore also
-       *  the length of this vector depends
-       *  on the dimension: in one dimension,
-       *  the length of this vector equals
-       *  the length of the @p lines vector,
-       *  in two dimensions that of the @p
-       *  quads vector, etc. The vector stores one element per cell
-       *  since the actiev_fe_index is unique for cells.
+       * Indices specifying the finite element of hp::FECollection to
+       * use for the different cells on the current level. The vector
+       * stores one element per cell since the active_fe_index is
+       * unique for cells.
+       *
+       * If a cell is not active on the level corresponding to the
+       * current object (i.e., it has children on higher levels) then
+       * it does not have an associated fe index and we store
+       * an invalid fe index marker instead.
        */
       std::vector<unsigned int> active_fe_indices;
 
       /**
-       * Store the start index for
-       * the degrees of freedom of each
-       * object in the @p dofs array.
+       * Store the start index for the degrees of freedom of each
+       * object in the @p dofs array. If the cell corresponding to
+       * a particular index in this array is not active on this level,
+       * then we do not store any DoFs for it. In that case, the offset
+       * we store here must be an invalid number and indeed we store
+       * <code>(std::vector<types::global_dof_index>::size_type)(-1)</code>
+       * for it.
        *
        * The type we store is then obviously the type the @p dofs array
        * uses for indexing.
@@ -87,10 +89,9 @@ namespace internal
       std::vector<std::vector<types::global_dof_index>::size_type> dof_offsets;
 
       /**
-       * Store the global indices of
-       * the degrees of freedom. See
-       * DoFLevel() for detailed
-       * information.
+       * Store the global indices of the degrees of freedom.
+       * information. The dof_offsets field determines where each
+       * (active) cell's data is stored.
        */
       std::vector<types::global_dof_index> dofs;
 

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.