]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Remove deprecated multigrid transfer build_matrices() functions 12376/head
authorDaniel Arndt <arndtd@ornl.gov>
Tue, 1 Jun 2021 17:30:53 +0000 (13:30 -0400)
committerDaniel Arndt <arndtd@ornl.gov>
Tue, 1 Jun 2021 17:33:25 +0000 (13:33 -0400)
doc/news/changes/incompatibilities/20210601DanielArndt-1 [new file with mode: 0644]
include/deal.II/multigrid/mg_transfer.h
include/deal.II/multigrid/mg_transfer_block.h
include/deal.II/multigrid/mg_transfer_component.h
source/multigrid/mg_transfer_block.cc
source/multigrid/mg_transfer_block.inst.in
source/multigrid/mg_transfer_component.cc
source/multigrid/mg_transfer_component.inst.in
source/multigrid/mg_transfer_prebuilt.cc
source/multigrid/mg_transfer_prebuilt.inst.in
tests/multigrid/mg_data_out_03.cc

diff --git a/doc/news/changes/incompatibilities/20210601DanielArndt-1 b/doc/news/changes/incompatibilities/20210601DanielArndt-1
new file mode 100644 (file)
index 0000000..2a67410
--- /dev/null
@@ -0,0 +1,4 @@
+Removed: The deprecated build_matrices() member functions
+in various multigrid transfer classes have been removed.
+<br>
+(Daniel Arndt, 2021/06/01)
index 05c3045df459c1bdf1558aadfbc07e8334487a38..b20acc46aaec85e2956467b556d3a0098ffbcff3 100644 (file)
@@ -673,15 +673,6 @@ public:
   void
   build(const DoFHandler<dim, spacedim> &dof_handler);
 
-  /**
-   * Actually build the prolongation matrices for each level.
-   *
-   * @deprecated use build() instead.
-   */
-  template <int dim, int spacedim>
-  DEAL_II_DEPRECATED void
-  build_matrices(const DoFHandler<dim, spacedim> &dof_handler);
-
   /**
    * Prolongate a vector from level <tt>to_level-1</tt> to level
    * <tt>to_level</tt> using the embedding matrices of the underlying finite
index f66473a7368eb49d319d8a702be0eac34f100de4..9a3e60b5830112dd62fcafab047bf0dafc35f7a1 100644 (file)
@@ -89,20 +89,6 @@ protected:
   void
   build(const DoFHandler<dim, spacedim> &dof_handler);
 
-  /**
-   * Actually build the prolongation matrices for each level.
-   *
-   * This function is only called by derived classes. These can also set the
-   * member variables #selected and others to restrict the transfer matrices
-   * to certain blocks.
-   *
-   * @deprecated Use build() instead.
-   */
-  template <int dim, int spacedim>
-  DEAL_II_DEPRECATED void
-  build_matrices(const DoFHandler<dim, spacedim> &dof,
-                 const DoFHandler<dim, spacedim> &mg_dof);
-
   /**
    * Flag of selected blocks.
    *
@@ -227,20 +213,6 @@ public:
   build(const DoFHandler<dim, spacedim> &dof_handler,
         const std::vector<bool> &        selected);
 
-  /**
-   * Build the prolongation matrices for each level.
-   *
-   * This function is a front-end for the same function in
-   * MGTransferBlockBase.
-   *
-   * @deprecated Use the build() function instead.
-   */
-  template <int dim, int spacedim>
-  DEAL_II_DEPRECATED void
-  build_matrices(const DoFHandler<dim, spacedim> &dof,
-                 const DoFHandler<dim, spacedim> &mg_dof,
-                 const std::vector<bool> &        selected);
-
   virtual void
   prolongate(const unsigned int         to_level,
              BlockVector<number> &      dst,
@@ -355,25 +327,6 @@ public:
   void
   build(const DoFHandler<dim, spacedim> &dof_handler, unsigned int selected);
 
-  /**
-   * Actually build the prolongation matrices for grouped blocks.
-   *
-   * This function is a front-end for the same function in
-   * MGTransferBlockBase.
-   *
-   * @param dof The DoFHandler for the active degrees of freedom to use.
-   * @param mg_dof The DoFHandler for the level degrees of freedom to use.
-   * @param selected Number of the block of the global vector to be copied from
-   * and to the multilevel vector.
-   *
-   * @deprecated Use build() instead.
-   */
-  template <int dim, int spacedim>
-  DEAL_II_DEPRECATED void
-  build_matrices(const DoFHandler<dim, spacedim> &dof,
-                 const DoFHandler<dim, spacedim> &mg_dof,
-                 unsigned int                     selected);
-
   /**
    * Change selected block. Handle with care!
    */
index 424d4848abf382f6df7c5c9aef32981d13e871db..091b9944d922a6b9d243a3289da7d26e42033b6e 100644 (file)
@@ -83,23 +83,6 @@ protected:
   void
   build(const DoFHandler<dim, spacedim> &dof_handler);
 
-  /**
-   * Actually build the prolongation matrices for each level.
-   *
-   * This function is only called by derived classes. These can also set the
-   * member variables <code>selected_component</code> and
-   * <code>mg_selected_component</code> member variables to restrict the
-   * transfer matrices to certain components. Furthermore, they use
-   * <code>target_component</code> and <code>mg_target_component</code> for
-   * re-ordering and grouping of components.
-   *
-   * @deprecated Use build() instead.
-   */
-  template <int dim, int spacedim>
-  DEAL_II_DEPRECATED void
-  build_matrices(const DoFHandler<dim, spacedim> &dof,
-                 const DoFHandler<dim, spacedim> &mg_dof);
-
   /**
    * Flag of selected components.
    *
@@ -208,47 +191,6 @@ public:
   virtual ~MGTransferSelect() override = default;
 
   // TODO: rewrite docs; make sure defaulted args are actually allowed
-  /**
-   * Actually build the prolongation matrices for grouped components.
-   *
-   * This function is a front-end for the same function in
-   * MGTransferComponentBase.
-   *
-   * @arg selected: Number of the block of the global vector to be copied from
-   * and to the multilevel vector. This number refers to the renumbering by
-   * <tt>target_component</tt>.
-   *
-   * @arg mg_selected: Number of the block for which the transfer matrices
-   * should be built.
-   *
-   * If <tt>mg_target_component</tt> is present, this refers to the renumbered
-   * components.
-   *
-   * @arg target_component: this argument allows grouping and renumbering of
-   * components in the fine-level vector (see DoFRenumbering::component_wise).
-   *
-   * @arg mg_target_component: this argument allows grouping and renumbering
-   * of components in the level vectors (see DoFRenumbering::component_wise).
-   * It also affects the behavior of the <tt>selected</tt> argument
-   *
-   * @arg boundary_indices: holds the boundary indices on each level.
-   *
-   * @deprecated Use build() instead.
-   */
-  template <int dim, int spacedim>
-  DEAL_II_DEPRECATED void
-  build_matrices(
-    const DoFHandler<dim, spacedim> &dof,
-    const DoFHandler<dim, spacedim> &mg_dof,
-    unsigned int                     selected,
-    unsigned int                     mg_selected,
-    const std::vector<unsigned int> &target_component =
-      std::vector<unsigned int>(),
-    const std::vector<unsigned int> &mg_target_component =
-      std::vector<unsigned int>(),
-    const std::vector<std::set<types::global_dof_index>> &boundary_indices =
-      std::vector<std::set<types::global_dof_index>>());
-
   /**
    * Actually build the prolongation matrices for grouped components.
    *
index 9294c91a5eb44f6b10b3794340818ab9310bc2a8..ba62ef55c0969d5fc2d4c571f192f792f88a5d3e 100644 (file)
@@ -202,17 +202,6 @@ MGTransferBlock<number>::copy_to_mg(
 
 
 
-template <int dim, int spacedim>
-void
-MGTransferBlockBase::build_matrices(
-  const DoFHandler<dim, spacedim> & /*dof*/,
-  const DoFHandler<dim, spacedim> &mg_dof_handler)
-{
-  build(mg_dof_handler);
-}
-
-
-
 template <int dim, int spacedim>
 void
 MGTransferBlockBase::build(const DoFHandler<dim, spacedim> &dof_handler)
@@ -477,17 +466,6 @@ MGTransferBlockBase::build(const DoFHandler<dim, spacedim> &dof_handler)
     }
 }
 
-template <typename number>
-template <int dim, int spacedim>
-void
-MGTransferBlockSelect<number>::build_matrices(
-  const DoFHandler<dim, spacedim> & /*dof*/,
-  const DoFHandler<dim, spacedim> &mg_dof,
-  unsigned int                     select)
-{
-  build(mg_dof, select);
-}
-
 template <typename number>
 template <int dim, int spacedim>
 void
@@ -576,17 +554,6 @@ MGTransferBlockSelect<number>::build(
 }
 
 
-template <typename number>
-template <int dim, int spacedim>
-void
-MGTransferBlock<number>::build_matrices(
-  const DoFHandler<dim, spacedim> & /*dof*/,
-  const DoFHandler<dim, spacedim> &mg_dof,
-  const std::vector<bool> &        sel)
-{
-  build(mg_dof, sel);
-}
-
 template <typename number>
 template <int dim, int spacedim>
 void
index 920d11027e39da46e619966bb98636612751e302..036408959fd49f430609b7eaefdee8895cd126cf 100644 (file)
@@ -29,30 +29,6 @@ for (deal_II_dimension : DIMENSIONS)
     template void MGTransferBlockSelect<double>::build<deal_II_dimension>(
       const DoFHandler<deal_II_dimension> &, const unsigned int);
 
-    // deprecated:
-    template void MGTransferBlock<float>::build_matrices<deal_II_dimension>(
-      const DoFHandler<deal_II_dimension> &,
-      const DoFHandler<deal_II_dimension> &,
-      const std::vector<bool> &);
-
-    // deprecated:
-    template void MGTransferBlock<double>::build_matrices<deal_II_dimension>(
-      const DoFHandler<deal_II_dimension> &,
-      const DoFHandler<deal_II_dimension> &,
-      const std::vector<bool> &);
-
-    // deprecated:
-    template void MGTransferBlockSelect<float>::build_matrices<
-      deal_II_dimension>(const DoFHandler<deal_II_dimension> &,
-                         const DoFHandler<deal_II_dimension> &,
-                         const unsigned int);
-
-    // deprecated:
-    template void MGTransferBlockSelect<double>::build_matrices<
-      deal_II_dimension>(const DoFHandler<deal_II_dimension> &,
-                         const DoFHandler<deal_II_dimension> &,
-                         const unsigned int);
-
     template void MGTransferBlock<float>::copy_to_mg(
       const DoFHandler<deal_II_dimension> &,
       MGLevelObject<BlockVector<float>> &,
index b4f87eff70bebb896d6cf8ed83e0341e4e2d4bd4..74c1a0caa8d7b04e0a430bd74bba577b71a3b5c1 100644 (file)
@@ -252,16 +252,6 @@ MGTransferSelect<number>::do_copy_to_mg(
 
 
 
-template <int dim, int spacedim>
-void
-MGTransferComponentBase::build_matrices(const DoFHandler<dim, spacedim> &,
-                                        const DoFHandler<dim, spacedim> &mg_dof)
-{
-  build(mg_dof);
-}
-
-
-
 template <int dim, int spacedim>
 void
 MGTransferComponentBase::build(const DoFHandler<dim, spacedim> &mg_dof)
@@ -568,23 +558,6 @@ MGTransferComponentBase::build(const DoFHandler<dim, spacedim> &mg_dof)
 
 
 
-template <typename number>
-template <int dim, int spacedim>
-void
-MGTransferSelect<number>::build_matrices(
-  const DoFHandler<dim, spacedim> & /*dof*/,
-  const DoFHandler<dim, spacedim> &                     mg_dof,
-  unsigned int                                          select,
-  unsigned int                                          mg_select,
-  const std::vector<unsigned int> &                     t_component,
-  const std::vector<unsigned int> &                     mg_t_component,
-  const std::vector<std::set<types::global_dof_index>> &bdry_indices)
-{
-  build(mg_dof, select, mg_select, t_component, mg_t_component, bdry_indices);
-}
-
-
-
 template <typename number>
 template <int dim, int spacedim>
 void
index 129872a8cae2b2853f78f6bdb1ee76564139ded9..1f434b621e4a83a81cce19599d91d1905199a586 100644 (file)
@@ -33,26 +33,6 @@ for (deal_II_dimension : DIMENSIONS)
       const std::vector<unsigned int> &,
       const std::vector<std::set<types::global_dof_index>> &);
 
-    // deprecated:
-    template void MGTransferSelect<float>::build_matrices<deal_II_dimension>(
-      const DoFHandler<deal_II_dimension> &d,
-      const DoFHandler<deal_II_dimension> &,
-      unsigned int,
-      unsigned int,
-      const std::vector<unsigned int> &,
-      const std::vector<unsigned int> &,
-      const std::vector<std::set<types::global_dof_index>> &);
-
-    // deprecated:
-    template void MGTransferSelect<double>::build_matrices<deal_II_dimension>(
-      const DoFHandler<deal_II_dimension> &d,
-      const DoFHandler<deal_II_dimension> &,
-      unsigned int,
-      unsigned int,
-      const std::vector<unsigned int> &,
-      const std::vector<unsigned int> &,
-      const std::vector<std::set<types::global_dof_index>> &);
-
     template void MGTransferSelect<float>::copy_to_mg(
       const DoFHandler<deal_II_dimension> &,
       MGLevelObject<Vector<float>> &,
index f2ffcc0ec948de8c7298804a4fddee234bde765e..13ff599c019399e72d0ba2a3f689b1c743765ace 100644 (file)
@@ -345,17 +345,6 @@ MGTransferPrebuilt<VectorType>::build(
 
 
 
-template <typename VectorType>
-template <int dim, int spacedim>
-void
-MGTransferPrebuilt<VectorType>::build_matrices(
-  const DoFHandler<dim, spacedim> &dof_handler)
-{
-  build(dof_handler);
-}
-
-
-
 template <typename VectorType>
 void
 MGTransferPrebuilt<VectorType>::print_matrices(std::ostream &os) const
index f825afdf3f001a3db4fd132b798b769b4e3d3798..387aea8c97cfa20422c7858d3b249fe8abfde4fd 100644 (file)
@@ -24,7 +24,4 @@ for (deal_II_dimension : DIMENSIONS; V1 : VECTORS_WITH_MATRIX)
   {
     template void MGTransferPrebuilt<V1>::build<deal_II_dimension>(
       const DoFHandler<deal_II_dimension> &mg_dof);
-
-    template void MGTransferPrebuilt<V1>::build_matrices<deal_II_dimension>(
-      const DoFHandler<deal_II_dimension> &mg_dof);
   }
index 2737d26a35113d437ce10940db9e82e4f869608a..b76402a252a9a7ae756251ccdc254f818fc68c4a 100644 (file)
@@ -77,7 +77,7 @@ do_test()
 
     MGTransferPrebuilt<Vector<double>> transfer;
 
-    transfer.build_matrices(dof_handler);
+    transfer.build(dof_handler);
 
     // This is not quite the correct thing to do, but "interpolate_to_mg"
     // doesn't exist for serial vectors. Here it means that the level 0 is 0

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.