These functions have been available in namespace Utilities::MPI for a while already.
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 ----------------- -->
/* ---------------------------------------------------------------------
*
- * 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.
*
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
{
* 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
};
#ifdef DEAL_II_WITH_MPI
inline
-const Utilities::System::MinMaxAvg &
+const Utilities::MPI::MinMaxAvg &
Timer::get_data() const
{
return mpi_data;
* 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;
-
- /** @} */
}
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);
- }
-
-
}
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
// ---------------------------------------------------------------------
//
-// 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.
//
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);