Actual source code: mpiu.c

  1: #include <petscsys.h>
  2: #include <petsc/private/petscimpl.h>
  3: /*
  4:     Note that tag of 0 is ok because comm is a private communicator
  5:   generated below just for these routines.
  6: */

  8: PETSC_INTERN PetscErrorCode PetscSequentialPhaseBegin_Private(MPI_Comm comm, int ng)
  9: {
 10:   PetscMPIInt rank, size, tag = 0;
 11:   MPI_Status  status;

 13:   PetscFunctionBegin;
 14:   PetscCallMPI(MPI_Comm_size(comm, &size));
 15:   if (size == 1) PetscFunctionReturn(PETSC_SUCCESS);
 16:   PetscCallMPI(MPI_Comm_rank(comm, &rank));
 17:   if (rank) PetscCallMPI(MPI_Recv(NULL, 0, MPI_INT, rank - 1, tag, comm, &status));
 18:   /* Send to the next process in the group unless we are the last process */
 19:   if ((rank % ng) < ng - 1 && rank != size - 1) PetscCallMPI(MPI_Send(NULL, 0, MPI_INT, rank + 1, tag, comm));
 20:   PetscFunctionReturn(PETSC_SUCCESS);
 21: }

 23: PETSC_INTERN PetscErrorCode PetscSequentialPhaseEnd_Private(MPI_Comm comm, int ng)
 24: {
 25:   PetscMPIInt rank, size, tag = 0;
 26:   MPI_Status  status;

 28:   PetscFunctionBegin;
 29:   PetscCallMPI(MPI_Comm_rank(comm, &rank));
 30:   PetscCallMPI(MPI_Comm_size(comm, &size));
 31:   if (size == 1) PetscFunctionReturn(PETSC_SUCCESS);

 33:   /* Send to the first process in the next group */
 34:   if ((rank % ng) == ng - 1 || rank == size - 1) PetscCallMPI(MPI_Send(NULL, 0, MPI_INT, (rank + 1) % size, tag, comm));
 35:   if (rank == 0) PetscCallMPI(MPI_Recv(NULL, 0, MPI_INT, size - 1, tag, comm, &status));
 36:   PetscFunctionReturn(PETSC_SUCCESS);
 37: }

 39: /* ---------------------------------------------------------------------*/
 40: /*
 41:     The variable Petsc_Seq_keyval is used to indicate an MPI attribute that
 42:   is attached to a communicator that manages the sequential phase code below.
 43: */
 44: PetscMPIInt Petsc_Seq_keyval = MPI_KEYVAL_INVALID;

 46: /*@
 47:   PetscSequentialPhaseBegin - Begins a sequential section of code.

 49:   Collective

 51:   Input Parameters:
 52: + comm - Communicator to sequentialize over
 53: - ng   - Number in processor group.  This many processes are allowed to execute
 54:    at the same time (usually 1)

 56:   Level: intermediate

 58:   Notes:
 59:   `PetscSequentialPhaseBegin()` and `PetscSequentialPhaseEnd()` provide a
 60:   way to force a section of code to be executed by the processes in
 61:   rank order.  Typically, this is done with
 62: .vb
 63:       PetscSequentialPhaseBegin(comm, 1);
 64:       <code to be executed sequentially>
 65:       PetscSequentialPhaseEnd(comm, 1);
 66: .ve

 68:   You should use `PetscSynchronizedPrintf()` to ensure output between MPI ranks is properly order and not these routines.

 70: .seealso: `PetscSequentialPhaseEnd()`, `PetscSynchronizedPrintf()`
 71: @*/
 72: PetscErrorCode PetscSequentialPhaseBegin(MPI_Comm comm, int ng)
 73: {
 74:   PetscMPIInt size;
 75:   MPI_Comm    local_comm, *addr_local_comm;

 77:   PetscFunctionBegin;
 78:   PetscCall(PetscSysInitializePackage());
 79:   PetscCallMPI(MPI_Comm_size(comm, &size));
 80:   if (size == 1) PetscFunctionReturn(PETSC_SUCCESS);

 82:   /* Get the private communicator for the sequential operations */
 83:   if (Petsc_Seq_keyval == MPI_KEYVAL_INVALID) PetscCallMPI(MPI_Comm_create_keyval(MPI_COMM_NULL_COPY_FN, MPI_COMM_NULL_DELETE_FN, &Petsc_Seq_keyval, NULL));

 85:   PetscCallMPI(MPI_Comm_dup(comm, &local_comm));
 86:   PetscCall(PetscMalloc1(1, &addr_local_comm));

 88:   *addr_local_comm = local_comm;

 90:   PetscCallMPI(MPI_Comm_set_attr(comm, Petsc_Seq_keyval, (void *)addr_local_comm));
 91:   PetscCall(PetscSequentialPhaseBegin_Private(local_comm, ng));
 92:   PetscFunctionReturn(PETSC_SUCCESS);
 93: }

 95: /*@
 96:   PetscSequentialPhaseEnd - Ends a sequential section of code.

 98:   Collective

100:   Input Parameters:
101: + comm - Communicator to sequentialize.
102: - ng   - Number in processor group.  This many processes are allowed to execute
103:    at the same time (usually 1)

105:   Level: intermediate

107:   Note:
108:   See `PetscSequentialPhaseBegin()` for more details.

110: .seealso: `PetscSequentialPhaseBegin()`
111: @*/
112: PetscErrorCode PetscSequentialPhaseEnd(MPI_Comm comm, int ng)
113: {
114:   PetscMPIInt size, flag;
115:   MPI_Comm    local_comm, *addr_local_comm;

117:   PetscFunctionBegin;
118:   PetscCallMPI(MPI_Comm_size(comm, &size));
119:   if (size == 1) PetscFunctionReturn(PETSC_SUCCESS);

121:   PetscCallMPI(MPI_Comm_get_attr(comm, Petsc_Seq_keyval, (void **)&addr_local_comm, &flag));
122:   PetscCheck(flag, PETSC_COMM_SELF, PETSC_ERR_ARG_INCOMP, "Wrong MPI communicator; must pass in one used with PetscSequentialPhaseBegin()");
123:   local_comm = *addr_local_comm;

125:   PetscCall(PetscSequentialPhaseEnd_Private(local_comm, ng));

127:   PetscCall(PetscFree(addr_local_comm));
128:   PetscCallMPI(MPI_Comm_free(&local_comm));
129:   PetscCallMPI(MPI_Comm_delete_attr(comm, Petsc_Seq_keyval));
130:   PetscFunctionReturn(PETSC_SUCCESS);
131: }

133: /*@C
134:   PetscGlobalMinMaxInt - Get the global min/max from local min/max input

136:   Collective

138:   Input Parameters:
139: + comm      - The MPI communicator to reduce with
140: - minMaxVal - An array with the local min and max

142:   Output Parameter:
143: . minMaxValGlobal - An array with the global min and max

145:   Level: beginner

147: .seealso: `PetscSplitOwnership()`, `PetscGlobalMinMaxReal()`
148: @*/
149: PetscErrorCode PetscGlobalMinMaxInt(MPI_Comm comm, const PetscInt minMaxVal[2], PetscInt minMaxValGlobal[2])
150: {
151:   PetscInt sendbuf[3], recvbuf[3];

153:   PetscFunctionBegin;
154:   sendbuf[0] = -minMaxVal[0]; /* Note that -PETSC_MIN_INT = PETSC_MIN_INT */
155:   sendbuf[1] = minMaxVal[1];
156:   sendbuf[2] = (minMaxVal[0] == PETSC_MIN_INT) ? 1 : 0; /* Are there PETSC_MIN_INT in minMaxVal[0]? */
157:   PetscCall(MPIU_Allreduce(sendbuf, recvbuf, 3, MPIU_INT, MPI_MAX, comm));
158:   minMaxValGlobal[0] = recvbuf[2] ? PETSC_MIN_INT : -recvbuf[0];
159:   minMaxValGlobal[1] = recvbuf[1];
160:   PetscFunctionReturn(PETSC_SUCCESS);
161: }

163: /*@C
164:   PetscGlobalMinMaxReal - Get the global min/max from local min/max input

166:   Collective

168:   Input Parameters:
169: + comm      - The MPI communicator to reduce with
170: - minMaxVal - An array with the local min and max

172:   Output Parameter:
173: . minMaxValGlobal - An array with the global min and max

175:   Level: beginner

177: .seealso: `PetscSplitOwnership()`, `PetscGlobalMinMaxInt()`
178: @*/
179: PetscErrorCode PetscGlobalMinMaxReal(MPI_Comm comm, const PetscReal minMaxVal[2], PetscReal minMaxValGlobal[2])
180: {
181:   PetscReal sendbuf[2];

183:   PetscFunctionBegin;
184:   sendbuf[0] = -minMaxVal[0];
185:   sendbuf[1] = minMaxVal[1];
186:   PetscCall(MPIU_Allreduce(sendbuf, minMaxValGlobal, 2, MPIU_REAL, MPIU_MAX, comm));
187:   minMaxValGlobal[0] = -minMaxValGlobal[0];
188:   PetscFunctionReturn(PETSC_SUCCESS);
189: }