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
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
// 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
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; i<n_buckets; ++i)
Assert (all_dof_counts[n_buckets*tria->locally_owned_subdomain()+i]
std::vector<unsigned int> 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
{
std::vector<unsigned int> 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