]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Remove set_vertex_dof_index(). 12984/head
authorDavid Wells <drwells@email.unc.edu>
Tue, 23 Nov 2021 01:53:12 +0000 (20:53 -0500)
committerDavid Wells <drwells@email.unc.edu>
Tue, 23 Nov 2021 02:11:56 +0000 (21:11 -0500)
This is no longer used as of e759ceee8e.

include/deal.II/dofs/dof_accessor.h
include/deal.II/dofs/dof_accessor.templates.h

index b3636f13b9827af245b3462473c6bd3440f6fc84..0ccf0c836987c0fcec18c59a8c6d836eb81b4689 100644 (file)
@@ -723,31 +723,6 @@ protected:
                    const unsigned int            i,
                    const types::global_dof_index index) const;
 
-  /**
-   * Set the global index of the <i>i</i> degree on the @p vertex-th vertex of
-   * the present cell to @p index.
-   *
-   * The last argument denotes the finite element index. For the standard
-   * ::DoFHandler class, this value must be equal to its default value since
-   * that class only supports the same finite element on all cells anyway.
-   *
-   * However, when the relevant DoFHandler has hp-capabilities, different
-   * finite element objects may be used on different cells. On faces between
-   * two cells, as well as vertices, there may therefore be two sets of
-   * degrees of freedom, one for each of the finite elements used on the
-   * adjacent cells.  In order to specify which set of degrees of freedom to
-   * work on, the last argument is used to disambiguate. Finally, if this
-   * function is called for a cell object, there can only be a single set of
-   * degrees of freedom, and fe_index has to match the result of
-   * active_fe_index().
-   */
-  void
-  set_vertex_dof_index(const unsigned int            vertex,
-                       const unsigned int            i,
-                       const types::global_dof_index index,
-                       const unsigned int            fe_index =
-                         DoFHandler<dim, spacedim>::invalid_fe_index) const;
-
   void
   set_mg_vertex_dof_index(const int                     level,
                           const unsigned int            vertex,
@@ -1228,31 +1203,6 @@ protected:
     const types::global_dof_index index,
     const unsigned int fe_index = AccessorData::invalid_fe_index) const;
 
-  /**
-   * Set the global index of the <i>i</i> degree on the @p vertex-th vertex of
-   * the present cell to @p index.
-   *
-   * The last argument denotes the finite element index. For the standard
-   * ::DoFHandler class, this value must be equal to its default value since
-   * that class only supports the same finite element on all cells anyway.
-   *
-   * However, when the relevant DoFHandler has hp-capabilities, different
-   * finite element objects may be used on different cells. On faces between
-   * two cells, as well as vertices, there may therefore be two sets of
-   * degrees of freedom, one for each of the finite elements used on the
-   * adjacent cells.  In order to specify which set of degrees of freedom to
-   * work on, the last argument is used to disambiguate. Finally, if this
-   * function is called for a cell object, there can only be a single set of
-   * degrees of freedom, and fe_index has to match the result of
-   * active_fe_index().
-   */
-  void
-  set_vertex_dof_index(
-    const unsigned int            vertex,
-    const unsigned int            i,
-    const types::global_dof_index index,
-    const unsigned int fe_index = AccessorData::invalid_fe_index) const;
-
   // Iterator classes need to be friends because they need to access
   // operator== and operator!=.
   template <typename>
index 95223ebe548f3ac8a6bf44a3fec59021003bc11f..44e63875d0cd9e83a3f97c86547048debe2e9328 100644 (file)
@@ -1581,30 +1581,6 @@ DoFAccessor<structdim, dim, spacedim, level_dof_access>::mg_vertex_dof_index(
 }
 
 
-template <int structdim, int dim, int spacedim, bool level_dof_access>
-inline void
-DoFAccessor<structdim, dim, spacedim, level_dof_access>::set_vertex_dof_index(
-  const unsigned int            vertex,
-  const unsigned int            i,
-  const types::global_dof_index index,
-  const unsigned int            fe_index_) const
-{
-  const unsigned int fe_index =
-    (this->dof_handler->hp_capability_enabled == false &&
-     fe_index_ == DoFHandler<dim, spacedim>::invalid_fe_index) ?
-      DoFHandler<dim, spacedim>::default_fe_index :
-      fe_index_;
-
-  dealii::internal::DoFAccessorImplementation::Implementation::set_dof_index(
-    *this->dof_handler,
-    0,
-    this->vertex_index(vertex),
-    fe_index,
-    i,
-    std::integral_constant<int, 0>(),
-    index);
-}
-
 
 template <int structdim, int dim, int spacedim, bool level_dof_access>
 inline void
@@ -1908,19 +1884,6 @@ DoFAccessor<0, 1, spacedim, level_dof_access>::set_dof_index(
 
 
 
-template <int spacedim, bool level_dof_access>
-inline void
-DoFAccessor<0, 1, spacedim, level_dof_access>::set_vertex_dof_index(
-  const unsigned int /*vertex*/,
-  const unsigned int /*i*/,
-  const types::global_dof_index /*index*/,
-  const unsigned int /*fe_index*/) const
-{
-  Assert(false, ExcNotImplemented());
-}
-
-
-
 template <int spacedim, bool level_dof_access>
 inline const DoFHandler<1, spacedim> &
 DoFAccessor<0, 1, spacedim, level_dof_access>::get_dof_handler() const

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.