From: Wolfgang Bangerth Date: Sun, 4 Jan 2015 21:32:12 +0000 (-0600) Subject: Remove deprecated MPI support functions in namespace Utilities and Utilities::System. X-Git-Tag: v8.3.0-rc1~563^2~13 X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=c6d8179733847f4df7b5cdaeb53533d9c8d0c64a;p=dealii.git Remove deprecated MPI support functions in namespace Utilities and Utilities::System. These functions have been available in namespace Utilities::MPI for a while already. --- diff --git a/doc/news/changes.h b/doc/news/changes.h index 54ef64944c..fd393c79c7 100644 --- a/doc/news/changes.h +++ b/doc/news/changes.h @@ -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. + diff --git a/examples/step-48/step-48.cc b/examples/step-48/step-48.cc index b82685bba9..5c2c2a2db9 100644 --- a/examples/step-48/step-48.cc +++ b/examples/step-48/step-48.cc @@ -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 { diff --git a/include/deal.II/base/timer.h b/include/deal.II/base/timer.h index 1bbc9643b1..a27962ffbe 100644 --- a/include/deal.II/base/timer.h +++ b/include/deal.II/base/timer.h @@ -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; diff --git a/include/deal.II/base/utilities.h b/include/deal.II/base/utilities.h index 6cd5f78470..a005889de2 100644 --- a/include/deal.II/base/utilities.h +++ b/include/deal.II/base/utilities.h @@ -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; - - /** @} */ } diff --git a/source/base/utilities.cc b/source/base/utilities.cc index 083c8df117..2de85686a2 100644 --- a/source/base/utilities.cc +++ b/source/base/utilities.cc @@ -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(&communicator); if (mpi_comm != 0) - return new Epetra_MpiComm(Utilities::System:: + return new Epetra_MpiComm(Utilities::MPI:: duplicate_communicator(mpi_comm->GetMpiComm())); #endif diff --git a/tests/mpi/collective_01.cc b/tests/mpi/collective_01.cc index 6edd3a234b..b6c06f8058 100644 --- a/tests/mpi/collective_01.cc +++ b/tests/mpi/collective_01.cc @@ -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);