]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Extend documentation
authorMartin Kronbichler <kronbichler@lnm.mw.tum.de>
Fri, 20 Oct 2017 16:27:58 +0000 (18:27 +0200)
committerMartin Kronbichler <kronbichler@lnm.mw.tum.de>
Fri, 20 Oct 2017 17:44:08 +0000 (19:44 +0200)
include/deal.II/dofs/dof_handler.h
source/dofs/dof_tools.cc

index 8abdbd1e1261ff1199da31285df56ed53d1413d8..cc51795caf64be2daab560386b7da94c619985b8 100644 (file)
@@ -828,7 +828,6 @@ public:
    */
   const IndexSet &locally_owned_mg_dofs(const unsigned int level) const;
 
-
   /**
    * Return a vector that stores the locally owned DoFs of each processor. If
    * you are only interested in the number of elements each processor owns
@@ -840,9 +839,6 @@ public:
   const std::vector<IndexSet> &
   locally_owned_dofs_per_processor () const;
 
-  const std::vector<IndexSet> &
-  locally_owned_mg_dofs_per_processor (const unsigned int level) const;
-
   /**
    * Return a vector that stores the number of degrees of freedom each
    * processor that participates in this triangulation owns locally. The sum
@@ -858,6 +854,16 @@ public:
   const std::vector<types::global_dof_index> &
   n_locally_owned_dofs_per_processor () const;
 
+  /**
+   * Return a vector that stores the locally owned DoFs of each processor on
+   * the given level @p level.
+   *
+   * If this is a sequential job, then the vector has a single element that
+   * equals the IndexSet representing the entire range [0,n_dofs()].
+   */
+  const std::vector<IndexSet> &
+  locally_owned_mg_dofs_per_processor (const unsigned int level) const;
+
   /**
    * Return a constant reference to the selected finite element object.
    * Since there is only one FiniteElement @p index must be equal to zero
index ab956ffcb8b924de130a5641d684fdb053d5bbf6..c115da2d8038d1a321ff51330bd2b066ae9d53ef 100644 (file)
@@ -1114,6 +1114,7 @@ namespace DoFTools
   }
 
 
+
   template <typename DoFHandlerType>
   void
   extract_locally_relevant_level_dofs (const DoFHandlerType &dof_handler,
@@ -1160,6 +1161,8 @@ namespace DoFTools
     dof_set.compress();
   }
 
+
+
   template <typename DoFHandlerType>
   void
   extract_constant_modes (const DoFHandlerType            &dof_handler,

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.