From 7455f69cace9bf21f21e875249c730d5673cbfeb Mon Sep 17 00:00:00 2001 From: Wolfgang Bangerth Date: Sat, 22 Jan 2011 20:52:13 +0000 Subject: [PATCH] Use MPI_UNSIGNED instead of MPI_INT where appropriate. git-svn-id: https://svn.dealii.org/trunk@23242 0785d39b-7218-0410-832d-ea1e28bc413d --- deal.II/source/dofs/dof_handler_policy.cc | 10 +++++----- deal.II/source/dofs/dof_renumbering.cc | 4 ++-- deal.II/source/dofs/dof_tools.cc | 4 ++-- 3 files changed, 9 insertions(+), 9 deletions(-) diff --git a/deal.II/source/dofs/dof_handler_policy.cc b/deal.II/source/dofs/dof_handler_policy.cc index f4458edc34..892526f760 100644 --- a/deal.II/source/dofs/dof_handler_policy.cc +++ b/deal.II/source/dofs/dof_handler_policy.cc @@ -1004,8 +1004,8 @@ namespace internal unsigned int sent=needs_to_get_cells.size(); unsigned int recv=senders.size(); - MPI_Reduce(&sent, &sum_send, 1, MPI_INT, MPI_SUM, 0, tr->get_communicator()); - MPI_Reduce(&recv, &sum_recv, 1, MPI_INT, MPI_SUM, 0, tr->get_communicator()); + MPI_Reduce(&sent, &sum_send, 1, MPI_UNSIGNED, MPI_SUM, 0, tr->get_communicator()); + MPI_Reduce(&recv, &sum_recv, 1, MPI_UNSIGNED, MPI_SUM, 0, tr->get_communicator()); Assert(sum_send==sum_recv, ExcInternalError()); } #endif @@ -1127,9 +1127,9 @@ namespace internal number_cache.n_locally_owned_dofs_per_processor.resize(n_cpus); MPI_Allgather ( &number_cache.n_locally_owned_dofs, - 1, MPI_INT, + 1, MPI_UNSIGNED, &number_cache.n_locally_owned_dofs_per_processor[0], - 1, MPI_INT, + 1, MPI_UNSIGNED, tr->get_communicator()); const unsigned int @@ -1506,7 +1506,7 @@ namespace internal // determine maximum size of IndexSet unsigned int max_size; - MPI_Allreduce(&my_size, &max_size, 1, MPI_INT, MPI_MAX, tr->get_communicator()); + MPI_Allreduce(&my_size, &max_size, 1, MPI_UNSIGNED, MPI_MAX, tr->get_communicator()); // as we are reading past the end, we // need to increase the size of the diff --git a/deal.II/source/dofs/dof_renumbering.cc b/deal.II/source/dofs/dof_renumbering.cc index 1eb552c568..dd49276ec9 100644 --- a/deal.II/source/dofs/dof_renumbering.cc +++ b/deal.II/source/dofs/dof_renumbering.cc @@ -834,8 +834,8 @@ namespace DoFRenumbering all_dof_counts(fe_collection.n_components() * Utilities::System::get_n_mpi_processes (tria->get_communicator())); - MPI_Allgather ( &local_dof_count[0], n_buckets, MPI_INT, &all_dof_counts[0], - n_buckets, MPI_INT, tria->get_communicator()); + MPI_Allgather ( &local_dof_count[0], n_buckets, MPI_UNSIGNED, &all_dof_counts[0], + n_buckets, MPI_UNSIGNED, tria->get_communicator()); for (unsigned int i=0; ilocally_owned_subdomain()+i] diff --git a/deal.II/source/dofs/dof_tools.cc b/deal.II/source/dofs/dof_tools.cc index bfe2586085..c9d59b8568 100644 --- a/deal.II/source/dofs/dof_tools.cc +++ b/deal.II/source/dofs/dof_tools.cc @@ -4340,7 +4340,7 @@ DoFTools::count_dofs_per_component ( std::vector local_dof_count = dofs_per_component; MPI_Allreduce ( &local_dof_count[0], &dofs_per_component[0], n_target_components, - MPI_INT, MPI_SUM, tria->get_communicator()); + MPI_UNSIGNED, MPI_SUM, tria->get_communicator()); } #endif #endif @@ -4417,7 +4417,7 @@ count_dofs_per_block (const DoFHandler& dof_handler, { std::vector local_dof_count = dofs_per_block; MPI_Allreduce ( &local_dof_count[0], &dofs_per_block[0], n_target_blocks, - MPI_INT, MPI_SUM, tria->get_communicator()); + MPI_UNSIGNED, MPI_SUM, tria->get_communicator()); } #endif #endif -- 2.39.5