]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Remove deprecated MPI support functions in namespace Utilities and Utilities::System.
authorWolfgang Bangerth <bangerth@math.tamu.edu>
Sun, 4 Jan 2015 21:32:12 +0000 (15:32 -0600)
committerWolfgang Bangerth <bangerth@math.tamu.edu>
Fri, 9 Jan 2015 06:56:00 +0000 (00:56 -0600)
These functions have been available in namespace Utilities::MPI for a while already.

doc/news/changes.h
examples/step-48/step-48.cc
include/deal.II/base/timer.h
include/deal.II/base/utilities.h
source/base/utilities.cc
tests/mpi/collective_01.cc

index 54ef64944c2eaf5576a78fbc9ad86c5e65fe98b8..fd393c79c7d14cb0fa87baeba8ded379b1f0035c 100644 (file)
@@ -97,6 +97,8 @@ inconvenience this causes.
   has been superseded by the signals defined by the triangulation
   class.
 - The deprecated constructor of MPI_InitFinalize
+- The MPI support functions in namespace Utilities and Utilities::System.
+
 
 <!-- ----------- GENERAL IMPROVEMENTS ----------------- -->
 
index b82685bba903083ee977db10f1fbf04f1c56d829..5c2c2a2db91b85510256b9907207c84a34c30009 100644 (file)
@@ -1,6 +1,6 @@
 /* ---------------------------------------------------------------------
  *
- * Copyright (C) 2011 - 2013 by the deal.II authors
+ * Copyright (C) 2011 - 2013, 2015 by the deal.II authors
  *
  * This file is part of the deal.II library.
  *
@@ -628,8 +628,8 @@ int main (int argc, char **argv)
   using namespace Step48;
   using namespace dealii;
 
-  Utilities::System::MPI_InitFinalize mpi_initialization(argc, argv,
-                                                         numbers::invalid_unsigned_int);
+  Utilities::MPI::MPI_InitFinalize mpi_initialization (argc, argv,
+                                                       numbers::invalid_unsigned_int);
 
   try
     {
index 1bbc9643b1923eab4ac9abfa7b1ab933a879c6a9..a27962ffbef9c8743b2733bc460b0427e903c6fc 100644 (file)
@@ -222,7 +222,7 @@ private:
    * average time defined as the sum of all individual times divided by the
    * number of MPI processes in the MPI_Comm.
    */
-  Utilities::System::MinMaxAvg mpi_data;
+  Utilities::MPI::MinMaxAvg mpi_data;
 #endif
 };
 
@@ -677,7 +677,7 @@ void Timer::restart ()
 #ifdef DEAL_II_WITH_MPI
 
 inline
-const Utilities::System::MinMaxAvg &
+const Utilities::MPI::MinMaxAvg &
 Timer::get_data() const
 {
   return mpi_data;
index 6cd5f78470c9cac7e16d3f115feada20fc35cc1f..a005889de2d18bd41fecd00b64446fdee2753ba1 100644 (file)
@@ -353,78 +353,6 @@ namespace Utilities
      * job that happens to run under MPI.
      */
     bool job_supports_mpi ();
-
-    /**
-     * Alias for job_supports_mpi().
-     *
-     * @deprecated
-     */
-    bool program_uses_mpi () DEAL_II_DEPRECATED;
-
-    /**
-     * @name Functions that work in parallel via MPI. The functions following
-     * here are all deprecated and have been moved to namespace
-     * Utilities::MPI.
-     */
-    /** @{ */
-
-    /**
-     * This function is an alias for Utilities::MPI::n_mpi_processes.
-     *
-     * @deprecated
-     */
-    unsigned int get_n_mpi_processes (const MPI_Comm &mpi_communicator) DEAL_II_DEPRECATED;
-
-    /**
-     * This function is an alias for Utilities::MPI::this_mpi_process.
-     *
-     * @deprecated
-     */
-    unsigned int get_this_mpi_process (const MPI_Comm &mpi_communicator) DEAL_II_DEPRECATED;
-
-
-    /**
-     * This function is an alias for
-     * Utilities::MPI::compute_point_to_point_communication_pattern.
-     *
-     * @deprecated
-     */
-    using
-    Utilities::MPI::compute_point_to_point_communication_pattern;
-
-
-    /**
-     * This function is an alias for Utilities::MPI::duplicate_communicator.
-     *
-     * @deprecated
-     */
-    using Utilities::MPI::duplicate_communicator;
-
-    /**
-     * An alias for Utilities::MPI::MinMaxAvg.
-     *
-     * @deprecated
-     */
-    using Utilities::MPI::MinMaxAvg;
-
-    /**
-     * An alias for Utilities::MPI::min_max_avg.
-     *
-     * @deprecated
-     */
-    void
-    calculate_collective_mpi_min_max_avg (const MPI_Comm &mpi_communicator,
-                                          const double my_value,
-                                          MinMaxAvg &result) DEAL_II_DEPRECATED;
-
-    /**
-     * An alias for Utilities::MPI::MPI_InitFinalize.
-     *
-     * @deprecated
-     */
-    using Utilities::MPI::MPI_InitFinalize;
-
-    /** @} */
   }
 
 
index 083c8df1176fd15f2c09971f0b9b2391db88fd0f..2de85686a2d1a31a70c9f369fcf5273a62ca3a24 100644 (file)
@@ -628,36 +628,6 @@ namespace Utilities
       return false;
 #endif
     }
-
-
-    bool
-    program_uses_mpi ()
-    {
-      return job_supports_mpi();
-    }
-
-
-    unsigned int get_n_mpi_processes (const MPI_Comm &mpi_communicator)
-    {
-      return MPI::n_mpi_processes (mpi_communicator);
-    }
-
-    unsigned int get_this_mpi_process (const MPI_Comm &mpi_communicator)
-    {
-      return MPI::this_mpi_process (mpi_communicator);
-    }
-
-
-
-    void calculate_collective_mpi_min_max_avg(const MPI_Comm &mpi_communicator,
-                                              double my_value,
-                                              MinMaxAvg &result)
-    {
-      result = Utilities::MPI::min_max_avg (my_value,
-                                            mpi_communicator);
-    }
-
-
   }
 
 
@@ -708,7 +678,7 @@ namespace Utilities
       const Epetra_MpiComm
       *mpi_comm = dynamic_cast<const Epetra_MpiComm *>(&communicator);
       if (mpi_comm != 0)
-        return new Epetra_MpiComm(Utilities::System::
+        return new Epetra_MpiComm(Utilities::MPI::
                                   duplicate_communicator(mpi_comm->GetMpiComm()));
 #endif
 
index 6edd3a234b35e75e221bb533a07903f2c182941f..b6c06f80583d40b768bac167fe7968423b7865fb 100644 (file)
@@ -1,6 +1,6 @@
 // ---------------------------------------------------------------------
 //
-// Copyright (C) 2009 - 2013 by the deal.II authors
+// Copyright (C) 2009 - 2013, 2015 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
@@ -41,7 +41,7 @@ void test()
   if (myid==0)
     deallog << "Running on " << numprocs << " CPU(s)." << std::endl;
 
-  Utilities::System::MinMaxAvg result;
+  Utilities::MPI::MinMaxAvg result;
 
   double value = 0.0;
   result = Utilities::MPI::min_max_avg(value, MPI_COMM_WORLD);

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.