* organization = {Springer}
* }
* @endcode
+ *
+ * @deprecated Use MPI_Comm_create_group directly
*/
#ifdef DEAL_II_WITH_MPI
- int
+ DEAL_II_DEPRECATED_EARLY int
create_group(const MPI_Comm & comm,
const MPI_Group &group,
const int tag,
const int tag,
MPI_Comm * new_comm)
{
- return MPI_Comm_create_group(comm, group, tag, new_comm);
+ const int ierr = MPI_Comm_create_group(comm, group, tag, new_comm);
+ AssertThrowMPI(ierr);
+ return ierr;
}
const int mpi_tag =
Utilities::MPI::internal::Tags::process_grid_constructor;
- ierr = Utilities::MPI::create_group(mpi_communicator,
- inactive_with_root_group,
- mpi_tag,
- &mpi_communicator_inactive_with_root);
+ ierr = MPI_Comm_create_group(mpi_communicator,
+ inactive_with_root_group,
+ mpi_tag,
+ &mpi_communicator_inactive_with_root);
AssertThrowMPI(ierr);
ierr = MPI_Group_free(&all_group);
MPI_Comm communicator_B;
const int mpi_tag = Utilities::MPI::internal::Tags::scalapack_copy_from;
- Utilities::MPI::create_group(this->grid->mpi_communicator,
- group_B,
- mpi_tag,
- &communicator_B);
+ const int ierr = MPI_Comm_create_group(this->grid->mpi_communicator,
+ group_B,
+ mpi_tag,
+ &communicator_B);
+ AssertThrowMPI(ierr);
int n_proc_rows_B = 1, n_proc_cols_B = 1;
int this_process_row_B = -1, this_process_column_B = -1;
int blacs_context_B = -1;
MPI_Comm communicator_B;
const int mpi_tag = Utilities::MPI::internal::Tags::scalapack_copy_to;
- Utilities::MPI::create_group(this->grid->mpi_communicator,
- group_B,
- mpi_tag,
- &communicator_B);
+ const int ierr = MPI_Comm_create_group(this->grid->mpi_communicator,
+ group_B,
+ mpi_tag,
+ &communicator_B);
+ AssertThrowMPI(ierr);
int n_proc_rows_B = 1, n_proc_cols_B = 1;
int this_process_row_B = -1, this_process_column_B = -1;
int blacs_context_B = -1;
// processes. the same holds for the wrapper/fallback we are using here.
const int mpi_tag = Utilities::MPI::internal::Tags::scalapack_copy_to2;
- ierr = Utilities::MPI::create_group(MPI_COMM_WORLD,
- group_union,
- mpi_tag,
- &mpi_communicator_union);
+ ierr = MPI_Comm_create_group(MPI_COMM_WORLD,
+ group_union,
+ mpi_tag,
+ &mpi_communicator_union);
AssertThrowMPI(ierr);
/*