]> https://gitweb.dealii.org/ - dealii-svn.git/commitdiff
rename dof_indices() function to get_active_or_mg_dof_indices() and document a couple...
authorheister <heister@0785d39b-7218-0410-832d-ea1e28bc413d>
Tue, 12 Feb 2013 20:12:13 +0000 (20:12 +0000)
committerheister <heister@0785d39b-7218-0410-832d-ea1e28bc413d>
Tue, 12 Feb 2013 20:12:13 +0000 (20:12 +0000)
git-svn-id: https://svn.dealii.org/trunk@28338 0785d39b-7218-0410-832d-ea1e28bc413d

deal.II/include/deal.II/dofs/dof_accessor.h
deal.II/include/deal.II/dofs/dof_accessor.templates.h
deal.II/source/dofs/dof_renumbering.cc

index beebb359665561af27457d83f497adafacbb77ca..bac83d687bfe4c6a6787ab9bc312fcb820f144fd 100644 (file)
@@ -136,7 +136,7 @@ namespace internal
  * the dimension of the Triangulation this object refers to as well as
  * the dimension of the space into which it is embedded. Finally, the
  * template argument <code>level_dof_access</code> governs the
- * behavior of the function dof_indices(). See the section on Generic loops below.
+ * behavior of the function get_active_or_mg_dof_indices(). See the section on Generic loops below.
  *
  * <h3>Typedefs</h3>
  *
@@ -152,7 +152,7 @@ namespace internal
  * dofs of the active cells of the Triangulation or on the level dodfs
  * of a single level or the whole grid hierarchy. In order to use
  * polymorphism in such loops, they access degrees of freedom through
- * the function dof_indices(), which changes behavior according to the
+ * the function get_active_or_mg_dof_indices(), which changes behavior according to the
  * third template argument.  If the argument is false, then the active
  * dofs of active cells are accessed. If it is true, the level dofs
  * are used. DoFHandler has functions, for instance begin() and
@@ -160,7 +160,7 @@ namespace internal
  * they can be cast into each other, in case this is needed, since
  * they access the same data.
  *
- * It is highly recommended to use the function dof_indices() in
+ * It is highly recommended to use the function get_active_or_mg_dof_indices() in
  * generic loops in lieu of get_dof_indices() or get_mg_dof_indices().
  *
  * <h3>Inheritance</h3>
@@ -178,7 +178,7 @@ namespace internal
  *
  * @ingroup dofs
  * @ingroup Accessors
- * @author Wolfgang Bangerth, 1998, 2006, 2008, Timo Heister, Guido Kanschat, 2012
+ * @author Wolfgang Bangerth, 1998, 2006, 2008, Timo Heister, Guido Kanschat, 2012, 2013
  */
 template <int structdim, class DH, bool level_dof_access>
 class DoFAccessor : public dealii::internal::DoFAccessor::Inheritance<structdim, DH::dimension, DH::space_dimension>::BaseClass
@@ -306,7 +306,7 @@ public:
 
   /**
    * Tell the caller whether
-   * dof_indices() accesses active
+   * get_active_or_mg_dof_indices() accesses active
    * or level dofs.
    */
   static bool is_level_cell();
@@ -441,7 +441,23 @@ public:
   void get_dof_indices (std::vector<unsigned int> &dof_indices,
                         const unsigned int fe_index = DH::default_fe_index) const;
 
+  /**
+   * Return the indices of the dofs of this
+   * object in the standard ordering: dofs
+   * on vertex 0, dofs on vertex 1, ...
+   * dofs on line 0, dofs on line 1, ...,
+   * then quads, then hexes.
+   *
+   * It is assumed that the vector already
+   * has the right size beforehand. The
+   * indices refer to the local numbering
+   * for the level this line lives on.
+   */
   void get_mg_dof_indices (const int level, std::vector<unsigned int> &dof_indices, const unsigned int fe_index = DH::default_fe_index) const;
+
+  /**
+   * Sets the level DoF indices that are returned by get_mg_dof_indices.
+   */
   void set_mg_dof_indices (const int level, const std::vector<unsigned int> &dof_indices, const unsigned int fe_index = DH::default_fe_index);
 
   /**
@@ -484,6 +500,10 @@ public:
                                  const unsigned int i,
                                  const unsigned int fe_index = DH::default_fe_index) const;
 
+  /**
+   * Returns the Global DoF index of the <i>i degree associated with the @p
+   * vertexth vertex on the level @p level. Also see vertex_dof_index().
+   */
   unsigned int mg_vertex_dof_index (const int level, const unsigned int vertex, const unsigned int i, const unsigned int fe_index = DH::default_fe_index) const;
 
   /**
@@ -543,6 +563,9 @@ public:
   unsigned int dof_index (const unsigned int i,
                           const unsigned int fe_index = DH::default_fe_index) const;
 
+  /**
+   * Returns the dof_index on the given level. Also see dof_index.
+   */
   unsigned int mg_dof_index (const int level, const unsigned int i) const;
 
   /**
@@ -2076,11 +2099,9 @@ public:
    *
    * Examples for this use are in the implementation of DoFRenumbering.
    */
-  void dof_indices (std::vector<unsigned int> &dof_indices) const;
+  void get_active_or_mg_dof_indices (std::vector<unsigned int> &dof_indices) const;
 
   /**
-   * @deprecated Use dof_indices() instead.
-   *
    * Return the indices of the dofs of this
    * quad in the standard ordering: dofs
    * on vertex 0, dofs on vertex 1, etc,
@@ -2111,11 +2132,13 @@ public:
    *
    * This is a function which requires that the cell be active.
    *
+   * Also see get_active_or_mg_dof_indices().
+   *
    * @deprecated Currently, this function can also be called for non-active cells, if all degrees of freedom of the FiniteElement are located in vertices. This functionality will vanish in a future release.
    */
   void get_dof_indices (std::vector<unsigned int> &dof_indices) const;
   /**
-   * @deprecated Use dof_indices() with level_cell_iterator returned from begin_mg().
+   * @deprecated Use get_active_or_mg_dof_indices() with level_cell_iterator returned from begin_mg().
    *
    * Retrieve the global indices of the degrees of freedom on this cell in the level vector associated to the level of the cell.
    */
@@ -2170,6 +2193,11 @@ public:
    * given DoF handler class.
    */
   void set_dof_indices (const std::vector<unsigned int> &dof_indices);
+
+  /**
+   * Set the Level DoF indices of this
+   * cell to the given values.
+   */
   void set_mg_dof_indices (const std::vector<unsigned int> &dof_indices);
 
   /**
index 10aef3789fed1b87d37edf06cad19d98ec5bffd2..2f654a07a47b87eabf3f742e981c523d19d2d64b 100644 (file)
@@ -3635,7 +3635,7 @@ void DoFCellAccessor<DH,lda>::set_mg_dof_indices (const std::vector<unsigned int
 
 template<class DH, bool lda>
 inline
-void DoFCellAccessor<DH,lda>::dof_indices (std::vector<unsigned int> &dof_indices) const
+void DoFCellAccessor<DH,lda>::get_active_or_mg_dof_indices (std::vector<unsigned int> &dof_indices) const
 {
   if (lda)
     get_mg_dof_indices (dof_indices);
index c5ac2bbc769585a606b054630aae070ef16af8fa..3f0d782f33d3569a1a9983cfea8909aa39622442 100644 (file)
@@ -287,7 +287,7 @@ namespace DoFRenumbering
 
           dofs_on_this_cell.resize (dofs_per_cell);
 
-          cell->dof_indices (dofs_on_this_cell);
+          cell->get_active_or_mg_dof_indices (dofs_on_this_cell);
           for (unsigned int i=0; i<dofs_per_cell; ++i)
             for (unsigned int j=0; j<dofs_per_cell; ++j)
               if (dofs_on_this_cell[i] > dofs_on_this_cell[j])
@@ -668,7 +668,7 @@ namespace DoFRenumbering
           const unsigned int fe_index = cell->active_fe_index();
           const unsigned int dofs_per_cell = fe_collection[fe_index].dofs_per_cell;
           local_dof_indices.resize (dofs_per_cell);
-          cell->dof_indices (local_dof_indices);
+          cell->get_active_or_mg_dof_indices (local_dof_indices);
           for (unsigned int i=0; i<dofs_per_cell; ++i)
             if (start->get_dof_handler().locally_owned_dofs().is_element(local_dof_indices[i]))
               component_to_dof_map[component_list[fe_index][i]].
@@ -974,7 +974,7 @@ namespace DoFRenumbering
           const unsigned int fe_index = cell->active_fe_index();
           const unsigned int dofs_per_cell =fe_collection[fe_index].dofs_per_cell;
           local_dof_indices.resize (dofs_per_cell);
-          cell->dof_indices (local_dof_indices);
+          cell->get_active_or_mg_dof_indices (local_dof_indices);
           for (unsigned int i=0; i<dofs_per_cell; ++i)
             if (start->get_dof_handler().locally_owned_dofs().is_element(local_dof_indices[i]))
               block_to_dof_map[block_list[fe_index][i]].
@@ -1386,7 +1386,7 @@ namespace DoFRenumbering
         unsigned int n_cell_dofs = (*cell)->get_fe().n_dofs_per_cell();
         cell_dofs.resize(n_cell_dofs);
 
-        (*cell)->dof_indices(cell_dofs);
+        (*cell)->get_active_or_mg_dof_indices(cell_dofs);
 
         // Sort here to make sure that
         // degrees of freedom inside a
@@ -1459,7 +1459,7 @@ namespace DoFRenumbering
       {
         Assert ((*cell)->level() == (int) level, ExcInternalError());
 
-        (*cell)->dof_indices(cell_dofs);
+        (*cell)->get_active_or_mg_dof_indices(cell_dofs);
         std::sort(cell_dofs.begin(), cell_dofs.end());
 
         for (unsigned int i=0; i<n_cell_dofs; ++i)
@@ -1568,7 +1568,7 @@ namespace DoFRenumbering
             hp_fe_values.reinit (begin);
             const FEValues<DH::dimension> &fe_values =
               hp_fe_values.get_present_fe_values ();
-            begin->dof_indices(local_dof_indices);
+            begin->get_active_or_mg_dof_indices(local_dof_indices);
             const std::vector<Point<DH::space_dimension> > &points
               = fe_values.get_quadrature_points ();
             for (unsigned int i=0; i<dofs_per_cell; ++i)
@@ -1652,7 +1652,7 @@ namespace DoFRenumbering
         for ( ; begin != end; ++begin)
           {
             const typename Triangulation<DH::dimension,DH::space_dimension>::cell_iterator &begin_tria = begin;
-            begin->dof_indices(local_dof_indices);
+            begin->get_active_or_mg_dof_indices(local_dof_indices);
             fe_values.reinit (begin_tria);
             const std::vector<Point<DH::space_dimension> > &points
               = fe_values.get_quadrature_points ();

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.