* See the MPI 4.x standard for details.
*/
inline int
- MPI_Type_contiguous_c(MPI_Count count,
- MPI_Datatype oldtype,
- MPI_Datatype *newtype)
+ Type_contiguous_c(MPI_Count count,
+ MPI_Datatype oldtype,
+ MPI_Datatype *newtype)
{
# if MPI_VERSION >= 4
- return ::MPI_Type_contiguous_c(count, oldtype, newtype);
+ return MPI_Type_contiguous_c(count, oldtype, newtype);
# else
if (count <= LargeCount::mpi_max_int_count)
return MPI_Type_contiguous(count, oldtype, newtype);
* See the MPI 4.x standard for details.
*/
inline int
- MPI_Send_c(const void * buf,
- MPI_Count count,
- MPI_Datatype datatype,
- int dest,
- int tag,
- MPI_Comm comm)
+ Send_c(const void * buf,
+ MPI_Count count,
+ MPI_Datatype datatype,
+ int dest,
+ int tag,
+ MPI_Comm comm)
{
# if MPI_VERSION >= 4
- return ::MPI_Send_c(buf, count, datatype, dest, tag, comm);
+ return MPI_Send_c(buf, count, datatype, dest, tag, comm);
# else
if (count <= LargeCount::mpi_max_int_count)
return MPI_Send(buf, count, datatype, dest, tag, comm);
MPI_Datatype bigtype;
int ierr;
- ierr = MPI_Type_contiguous_c(count, datatype, &bigtype);
+ ierr = Type_contiguous_c(count, datatype, &bigtype);
if (ierr != MPI_SUCCESS)
return ierr;
ierr = MPI_Type_commit(&bigtype);
* See the MPI 4.x standard for details.
*/
inline int
- MPI_Recv_c(void * buf,
- MPI_Count count,
- MPI_Datatype datatype,
- int source,
- int tag,
- MPI_Comm comm,
- MPI_Status * status)
+ Recv_c(void * buf,
+ MPI_Count count,
+ MPI_Datatype datatype,
+ int source,
+ int tag,
+ MPI_Comm comm,
+ MPI_Status * status)
{
# if MPI_VERSION >= 4
- return ::MPI_Recv_c(buf, count, datatype, source, tag, comm, status);
+ return MPI_Recv_c(buf, count, datatype, source, tag, comm, status);
# else
if (count <= LargeCount::mpi_max_int_count)
return MPI_Recv(buf, count, datatype, source, tag, comm, status);
MPI_Datatype bigtype;
int ierr;
- ierr = MPI_Type_contiguous_c(count, datatype, &bigtype);
+ ierr = Type_contiguous_c(count, datatype, &bigtype);
if (ierr != MPI_SUCCESS)
return ierr;
* See the MPI 4.x standard for details.
*/
inline int
- MPI_Bcast_c(void * buf,
- MPI_Count count,
- MPI_Datatype datatype,
- unsigned int root_mpi_rank,
- MPI_Comm comm)
+ Bcast_c(void * buf,
+ MPI_Count count,
+ MPI_Datatype datatype,
+ unsigned int root_mpi_rank,
+ MPI_Comm comm)
{
# if MPI_VERSION >= 4
- return ::MPI_Bcast_c(buf, count, datatype, root_mpi_rank, comm);
+ return MPI_Bcast_c(buf, count, datatype, root_mpi_rank, comm);
# else
if (count <= LargeCount::mpi_max_int_count)
return MPI_Bcast(buf, count, datatype, root_mpi_rank, comm);
MPI_Datatype bigtype;
int ierr;
- ierr = MPI_Type_contiguous_c(count, datatype, &bigtype);
+ ierr = Type_contiguous_c(count, datatype, &bigtype);
if (ierr != MPI_SUCCESS)
return ierr;
ierr = MPI_Type_commit(&bigtype);
* See the MPI 4.x standard for details.
*/
inline int
- MPI_File_write_at_c(MPI_File fh,
- MPI_Offset offset,
- const void * buf,
- MPI_Count count,
- MPI_Datatype datatype,
- MPI_Status * status)
+ File_write_at_c(MPI_File fh,
+ MPI_Offset offset,
+ const void * buf,
+ MPI_Count count,
+ MPI_Datatype datatype,
+ MPI_Status * status)
{
if (count <= LargeCount::mpi_max_int_count)
return MPI_File_write_at(fh, offset, buf, count, datatype, status);
MPI_Datatype bigtype;
int ierr;
- ierr = MPI_Type_contiguous_c(count, datatype, &bigtype);
+ ierr = Type_contiguous_c(count, datatype, &bigtype);
if (ierr != MPI_SUCCESS)
return ierr;
ierr = MPI_Type_commit(&bigtype);
* See the MPI 4.x standard for details.
*/
inline int
- MPI_File_write_at_all_c(MPI_File fh,
- MPI_Offset offset,
- const void * buf,
- MPI_Count count,
- MPI_Datatype datatype,
- MPI_Status * status)
+ File_write_at_all_c(MPI_File fh,
+ MPI_Offset offset,
+ const void * buf,
+ MPI_Count count,
+ MPI_Datatype datatype,
+ MPI_Status * status)
{
if (count <= LargeCount::mpi_max_int_count)
return MPI_File_write_at_all(
MPI_Datatype bigtype;
int ierr;
- ierr = MPI_Type_contiguous_c(count, datatype, &bigtype);
+ ierr = Type_contiguous_c(count, datatype, &bigtype);
if (ierr != MPI_SUCCESS)
return ierr;
ierr = MPI_Type_commit(&bigtype);
* See the MPI 4.x standard for details.
*/
inline int
- MPI_File_write_ordered_c(MPI_File fh,
- const void * buf,
- MPI_Count count,
- MPI_Datatype datatype,
- MPI_Status * status)
+ File_write_ordered_c(MPI_File fh,
+ const void * buf,
+ MPI_Count count,
+ MPI_Datatype datatype,
+ MPI_Status * status)
{
if (count <= LargeCount::mpi_max_int_count)
return MPI_File_write_ordered(fh, buf, count, datatype, status);
MPI_Datatype bigtype;
int ierr;
- ierr = MPI_Type_contiguous_c(count, datatype, &bigtype);
+ ierr = Type_contiguous_c(count, datatype, &bigtype);
if (ierr != MPI_SUCCESS)
return ierr;
ierr = MPI_Type_commit(&bigtype);
* See the MPI 4.x standard for details.
*/
inline int
- MPI_File_read_at_c(MPI_File fh,
- MPI_Offset offset,
- void * buf,
- MPI_Count count,
- MPI_Datatype datatype,
- MPI_Status * status)
+ File_read_at_c(MPI_File fh,
+ MPI_Offset offset,
+ void * buf,
+ MPI_Count count,
+ MPI_Datatype datatype,
+ MPI_Status * status)
{
if (count <= LargeCount::mpi_max_int_count)
return MPI_File_read_at(fh, offset, buf, count, datatype, status);
MPI_Datatype bigtype;
int ierr;
- ierr = MPI_Type_contiguous_c(count, datatype, &bigtype);
+ ierr = Type_contiguous_c(count, datatype, &bigtype);
if (ierr != MPI_SUCCESS)
return ierr;
ierr = MPI_Type_commit(&bigtype);
* See the MPI 4.x standard for details.
*/
inline int
- MPI_File_read_at_all_c(MPI_File fh,
- MPI_Offset offset,
- void * buf,
- MPI_Count count,
- MPI_Datatype datatype,
- MPI_Status * status)
+ File_read_at_all_c(MPI_File fh,
+ MPI_Offset offset,
+ void * buf,
+ MPI_Count count,
+ MPI_Datatype datatype,
+ MPI_Status * status)
{
if (count <= LargeCount::mpi_max_int_count)
return MPI_File_read_at_all(fh, offset, buf, count, datatype, status);
MPI_Datatype bigtype;
int ierr;
- ierr = MPI_Type_contiguous_c(count, datatype, &bigtype);
+ ierr = Type_contiguous_c(count, datatype, &bigtype);
if (ierr != MPI_SUCCESS)
return ierr;
ierr = MPI_Type_commit(&bigtype);
// this task.
if (myrank == 0)
{
- ierr = Utilities::MPI::LargeCount::MPI_File_write_at_c(
+ ierr = Utilities::MPI::LargeCount::File_write_at_c(
fh,
0,
sizes_fixed_cumulative.data(),
static_cast<MPI_Offset>(global_first_cell) * bytes_per_cell;
ierr =
- Utilities::MPI::LargeCount::MPI_File_write_at_c(fh,
- my_global_file_position,
- src_data_fixed.data(),
- src_data_fixed.size(),
- MPI_BYTE,
- MPI_STATUS_IGNORE);
+ Utilities::MPI::LargeCount::File_write_at_c(fh,
+ my_global_file_position,
+ src_data_fixed.data(),
+ src_data_fixed.size(),
+ MPI_BYTE,
+ MPI_STATUS_IGNORE);
AssertThrowMPI(ierr);
ierr = MPI_File_close(&fh);
std::numeric_limits<int>::max()),
ExcNotImplemented());
- ierr = Utilities::MPI::LargeCount::MPI_File_write_at_c(
+ ierr = Utilities::MPI::LargeCount::File_write_at_c(
fh,
my_global_file_position,
src_sizes_variable.data(),
prefix_sum;
// Write data consecutively into file.
- ierr = Utilities::MPI::LargeCount::MPI_File_write_at_c(
- fh,
- my_global_file_position,
- src_data_variable.data(),
- src_data_variable.size(),
- MPI_BYTE,
- MPI_STATUS_IGNORE);
+ ierr =
+ Utilities::MPI::LargeCount::File_write_at_c(fh,
+ my_global_file_position,
+ src_data_variable.data(),
+ src_data_variable.size(),
+ MPI_BYTE,
+ MPI_STATUS_IGNORE);
AssertThrowMPI(ierr);
// location in the file.
sizes_fixed_cumulative.resize(1 + n_attached_deserialize_fixed +
(variable_size_data_stored ? 1 : 0));
- ierr = Utilities::MPI::LargeCount::MPI_File_read_at_c(
+ ierr = Utilities::MPI::LargeCount::File_read_at_c(
fh,
0,
sizes_fixed_cumulative.data(),
size_header +
static_cast<MPI_Offset>(global_first_cell) * bytes_per_cell;
- ierr =
- Utilities::MPI::LargeCount::MPI_File_read_at_c(fh,
- my_global_file_position,
- dest_data_fixed.data(),
- dest_data_fixed.size(),
- MPI_BYTE,
- MPI_STATUS_IGNORE);
+ ierr = Utilities::MPI::LargeCount::File_read_at_c(fh,
+ my_global_file_position,
+ dest_data_fixed.data(),
+ dest_data_fixed.size(),
+ MPI_BYTE,
+ MPI_STATUS_IGNORE);
AssertThrowMPI(ierr);
const MPI_Offset my_global_file_position_sizes =
static_cast<MPI_Offset>(global_first_cell) * sizeof(unsigned int);
- ierr = Utilities::MPI::LargeCount::MPI_File_read_at_c(
+ ierr = Utilities::MPI::LargeCount::File_read_at_c(
fh,
my_global_file_position_sizes,
dest_sizes_variable.data(),
dest_data_variable.resize(size_on_proc);
- ierr = Utilities::MPI::LargeCount::MPI_File_read_at_c(
- fh,
- my_global_file_position,
- dest_data_variable.data(),
- dest_data_variable.size(),
- MPI_BYTE,
- MPI_STATUS_IGNORE);
+ ierr =
+ Utilities::MPI::LargeCount::File_read_at_c(fh,
+ my_global_file_position,
+ dest_data_variable.data(),
+ dest_data_variable.size(),
+ MPI_BYTE,
+ MPI_STATUS_IGNORE);
AssertThrowMPI(ierr);
ierr = MPI_File_close(&fh);