Actual source code: dalocal.c


  2: /*
  3:   Code for manipulating distributed regular arrays in parallel.
  4: */

  6: #include <petsc/private/dmdaimpl.h>
  7: #include <petscbt.h>
  8: #include <petscsf.h>
  9: #include <petscds.h>
 10: #include <petscfe.h>

 12: /*
 13:    This allows the DMDA vectors to properly tell MATLAB their dimensions
 14: */
 15: #if defined(PETSC_HAVE_MATLAB_ENGINE)
 16: #include <engine.h>   /* MATLAB include file */
 17: #include <mex.h>      /* MATLAB include file */
 18: static PetscErrorCode  VecMatlabEnginePut_DA2d(PetscObject obj,void *mengine)
 19: {
 21:   PetscInt       n,m;
 22:   Vec            vec = (Vec)obj;
 23:   PetscScalar    *array;
 24:   mxArray        *mat;
 25:   DM             da;

 28:   VecGetDM(vec, &da);
 29:   if (!da) SETERRQ(PetscObjectComm((PetscObject)vec),PETSC_ERR_ARG_WRONGSTATE,"Vector not associated with a DMDA");
 30:   DMDAGetGhostCorners(da,0,0,0,&m,&n,0);

 32:   VecGetArray(vec,&array);
 33: #if !defined(PETSC_USE_COMPLEX)
 34:   mat = mxCreateDoubleMatrix(m,n,mxREAL);
 35: #else
 36:   mat = mxCreateDoubleMatrix(m,n,mxCOMPLEX);
 37: #endif
 38:   PetscArraycpy(mxGetPr(mat),array,n*m);
 39:   PetscObjectName(obj);
 40:   engPutVariable((Engine*)mengine,obj->name,mat);

 42:   VecRestoreArray(vec,&array);
 43:   return(0);
 44: }
 45: #endif

 47: PetscErrorCode  DMCreateLocalVector_DA(DM da,Vec *g)
 48: {
 50:   DM_DA          *dd = (DM_DA*)da->data;

 55:   VecCreate(PETSC_COMM_SELF,g);
 56:   VecSetSizes(*g,dd->nlocal,PETSC_DETERMINE);
 57:   VecSetBlockSize(*g,dd->w);
 58:   VecSetType(*g,da->vectype);
 59:   VecSetDM(*g, da);
 60: #if defined(PETSC_HAVE_MATLAB_ENGINE)
 61:   if (dd->w == 1  && da->dim == 2) {
 62:     PetscObjectComposeFunction((PetscObject)*g,"PetscMatlabEnginePut_C",VecMatlabEnginePut_DA2d);
 63:   }
 64: #endif
 65:   return(0);
 66: }

 68: /*@
 69:   DMDAGetNumCells - Get the number of cells in the local piece of the DMDA. This includes ghost cells.

 71:   Input Parameter:
 72: . dm - The DM object

 74:   Output Parameters:
 75: + numCellsX - The number of local cells in the x-direction
 76: . numCellsY - The number of local cells in the y-direction
 77: . numCellsZ - The number of local cells in the z-direction
 78: - numCells - The number of local cells

 80:   Level: developer

 82: .seealso: DMDAGetCellPoint()
 83: @*/
 84: PetscErrorCode DMDAGetNumCells(DM dm, PetscInt *numCellsX, PetscInt *numCellsY, PetscInt *numCellsZ, PetscInt *numCells)
 85: {
 86:   DM_DA         *da  = (DM_DA*) dm->data;
 87:   const PetscInt dim = dm->dim;
 88:   const PetscInt mx  = (da->Xe - da->Xs)/da->w, my = da->Ye - da->Ys, mz = da->Ze - da->Zs;
 89:   const PetscInt nC  = (mx)*(dim > 1 ? (my)*(dim > 2 ? (mz) : 1) : 1);

 93:   if (numCellsX) {
 95:     *numCellsX = mx;
 96:   }
 97:   if (numCellsY) {
 99:     *numCellsY = my;
100:   }
101:   if (numCellsZ) {
103:     *numCellsZ = mz;
104:   }
105:   if (numCells) {
107:     *numCells = nC;
108:   }
109:   return(0);
110: }

112: /*@
113:   DMDAGetCellPoint - Get the DM point corresponding to the tuple (i, j, k) in the DMDA

115:   Input Parameters:
116: + dm - The DM object
117: - i,j,k - The global indices for the cell

119:   Output Parameters:
120: . point - The local DM point

122:   Level: developer

124: .seealso: DMDAGetNumCells()
125: @*/
126: PetscErrorCode DMDAGetCellPoint(DM dm, PetscInt i, PetscInt j, PetscInt k, PetscInt *point)
127: {
128:   const PetscInt dim = dm->dim;
129:   DMDALocalInfo  info;

135:   DMDAGetLocalInfo(dm, &info);
136:   if (dim > 0) {if ((i < info.gxs) || (i >= info.gxs+info.gxm)) SETERRQ3(PETSC_COMM_SELF, PETSC_ERR_ARG_OUTOFRANGE, "X index %d not in [%d, %d)", i, info.gxs, info.gxs+info.gxm);}
137:   if (dim > 1) {if ((j < info.gys) || (j >= info.gys+info.gym)) SETERRQ3(PETSC_COMM_SELF, PETSC_ERR_ARG_OUTOFRANGE, "Y index %d not in [%d, %d)", j, info.gys, info.gys+info.gym);}
138:   if (dim > 2) {if ((k < info.gzs) || (k >= info.gzs+info.gzm)) SETERRQ3(PETSC_COMM_SELF, PETSC_ERR_ARG_OUTOFRANGE, "Z index %d not in [%d, %d)", k, info.gzs, info.gzs+info.gzm);}
139:   *point = i + (dim > 1 ? (j + (dim > 2 ? k*info.gym : 0))*info.gxm : 0);
140:   return(0);
141: }

143: PetscErrorCode DMDAGetNumVertices(DM dm, PetscInt *numVerticesX, PetscInt *numVerticesY, PetscInt *numVerticesZ, PetscInt *numVertices)
144: {
145:   DM_DA          *da = (DM_DA*) dm->data;
146:   const PetscInt dim = dm->dim;
147:   const PetscInt mx  = (da->Xe - da->Xs)/da->w, my = da->Ye - da->Ys, mz = da->Ze - da->Zs;
148:   const PetscInt nVx = mx+1;
149:   const PetscInt nVy = dim > 1 ? (my+1) : 1;
150:   const PetscInt nVz = dim > 2 ? (mz+1) : 1;
151:   const PetscInt nV  = nVx*nVy*nVz;

154:   if (numVerticesX) {
156:     *numVerticesX = nVx;
157:   }
158:   if (numVerticesY) {
160:     *numVerticesY = nVy;
161:   }
162:   if (numVerticesZ) {
164:     *numVerticesZ = nVz;
165:   }
166:   if (numVertices) {
168:     *numVertices = nV;
169:   }
170:   return(0);
171: }

173: PetscErrorCode DMDAGetNumFaces(DM dm, PetscInt *numXFacesX, PetscInt *numXFaces, PetscInt *numYFacesY, PetscInt *numYFaces, PetscInt *numZFacesZ, PetscInt *numZFaces)
174: {
175:   DM_DA          *da = (DM_DA*) dm->data;
176:   const PetscInt dim = dm->dim;
177:   const PetscInt mx  = (da->Xe - da->Xs)/da->w, my = da->Ye - da->Ys, mz = da->Ze - da->Zs;
178:   const PetscInt nxF = (dim > 1 ? (my)*(dim > 2 ? (mz) : 1) : 1);
179:   const PetscInt nXF = (mx+1)*nxF;
180:   const PetscInt nyF = mx*(dim > 2 ? mz : 1);
181:   const PetscInt nYF = dim > 1 ? (my+1)*nyF : 0;
182:   const PetscInt nzF = mx*(dim > 1 ? my : 0);
183:   const PetscInt nZF = dim > 2 ? (mz+1)*nzF : 0;

186:   if (numXFacesX) {
188:     *numXFacesX = nxF;
189:   }
190:   if (numXFaces) {
192:     *numXFaces = nXF;
193:   }
194:   if (numYFacesY) {
196:     *numYFacesY = nyF;
197:   }
198:   if (numYFaces) {
200:     *numYFaces = nYF;
201:   }
202:   if (numZFacesZ) {
204:     *numZFacesZ = nzF;
205:   }
206:   if (numZFaces) {
208:     *numZFaces = nZF;
209:   }
210:   return(0);
211: }

213: PetscErrorCode DMDAGetHeightStratum(DM dm, PetscInt height, PetscInt *pStart, PetscInt *pEnd)
214: {
215:   const PetscInt dim = dm->dim;
216:   PetscInt       nC, nV, nXF, nYF, nZF;

222:   DMDAGetNumCells(dm, NULL, NULL, NULL, &nC);
223:   DMDAGetNumVertices(dm, NULL, NULL, NULL, &nV);
224:   DMDAGetNumFaces(dm, NULL, &nXF, NULL, &nYF, NULL, &nZF);
225:   if (height == 0) {
226:     /* Cells */
227:     if (pStart) *pStart = 0;
228:     if (pEnd)   *pEnd   = nC;
229:   } else if (height == 1) {
230:     /* Faces */
231:     if (pStart) *pStart = nC+nV;
232:     if (pEnd)   *pEnd   = nC+nV+nXF+nYF+nZF;
233:   } else if (height == dim) {
234:     /* Vertices */
235:     if (pStart) *pStart = nC;
236:     if (pEnd)   *pEnd   = nC+nV;
237:   } else if (height < 0) {
238:     /* All points */
239:     if (pStart) *pStart = 0;
240:     if (pEnd)   *pEnd   = nC+nV+nXF+nYF+nZF;
241:   } else SETERRQ1(PetscObjectComm((PetscObject)dm), PETSC_ERR_ARG_OUTOFRANGE, "No points of height %d in the DA", height);
242:   return(0);
243: }

245: PetscErrorCode DMDAGetDepthStratum(DM dm, PetscInt depth, PetscInt *pStart, PetscInt *pEnd)
246: {
247:   const PetscInt dim = dm->dim;
248:   PetscInt       nC, nV, nXF, nYF, nZF;

254:   DMDAGetNumCells(dm, NULL, NULL, NULL, &nC);
255:   DMDAGetNumVertices(dm, NULL, NULL, NULL, &nV);
256:   DMDAGetNumFaces(dm, NULL, &nXF, NULL, &nYF, NULL, &nZF);
257:   if (depth == dim) {
258:     /* Cells */
259:     if (pStart) *pStart = 0;
260:     if (pEnd)   *pEnd   = nC;
261:   } else if (depth == dim-1) {
262:     /* Faces */
263:     if (pStart) *pStart = nC+nV;
264:     if (pEnd)   *pEnd   = nC+nV+nXF+nYF+nZF;
265:   } else if (depth == 0) {
266:     /* Vertices */
267:     if (pStart) *pStart = nC;
268:     if (pEnd)   *pEnd   = nC+nV;
269:   } else if (depth < 0) {
270:     /* All points */
271:     if (pStart) *pStart = 0;
272:     if (pEnd)   *pEnd   = nC+nV+nXF+nYF+nZF;
273:   } else SETERRQ1(PetscObjectComm((PetscObject)dm), PETSC_ERR_ARG_OUTOFRANGE, "No points of depth %d in the DA", depth);
274:   return(0);
275: }

277: PetscErrorCode DMDAGetConeSize(DM dm, PetscInt p, PetscInt *coneSize)
278: {
279:   const PetscInt dim = dm->dim;
280:   PetscInt       nC, nV, nXF, nYF, nZF;

284:   *coneSize = 0;
285:   DMDAGetNumCells(dm, NULL, NULL, NULL, &nC);
286:   DMDAGetNumVertices(dm, NULL, NULL, NULL, &nV);
287:   DMDAGetNumFaces(dm, NULL, &nXF, NULL, &nYF, NULL, &nZF);
288:   switch (dim) {
289:   case 2:
290:     if (p >= 0) {
291:       if (p < nC) {
292:         *coneSize = 4;
293:       } else if (p < nC+nV) {
294:         *coneSize = 0;
295:       } else if (p < nC+nV+nXF+nYF+nZF) {
296:         *coneSize = 2;
297:       } else SETERRQ2(PETSC_COMM_SELF, PETSC_ERR_ARG_OUTOFRANGE, "Point %d should be in [0, %d)", p, nC+nV+nXF+nYF+nZF);
298:     } else SETERRQ1(PETSC_COMM_SELF, PETSC_ERR_ARG_OUTOFRANGE, "Negative point %d is invalid", p);
299:     break;
300:   case 3:
301:     SETERRQ(PETSC_COMM_SELF, PETSC_ERR_SUP, "Too lazy to do 3D");
302:   }
303:   return(0);
304: }

306: PetscErrorCode DMDAGetCone(DM dm, PetscInt p, PetscInt *cone[])
307: {
308:   const PetscInt dim = dm->dim;
309:   PetscInt       nCx, nCy, nCz, nC, nVx, nVy, nVz, nV, nxF, nyF, nzF, nXF, nYF, nZF;

313:   if (!cone) {DMGetWorkArray(dm, 6, MPIU_INT, cone);}
314:   DMDAGetNumCells(dm, &nCx, &nCy, &nCz, &nC);
315:   DMDAGetNumVertices(dm, &nVx, &nVy, &nVz, &nV);
316:   DMDAGetNumFaces(dm, &nxF, &nXF, &nyF, &nYF, &nzF, &nZF);
317:   switch (dim) {
318:   case 2:
319:     if (p >= 0) {
320:       if (p < nC) {
321:         const PetscInt cy = p / nCx;
322:         const PetscInt cx = p % nCx;

324:         (*cone)[0] = cy*nxF + cx + nC+nV;
325:         (*cone)[1] = cx*nyF + cy + nyF + nC+nV+nXF;
326:         (*cone)[2] = cy*nxF + cx + nxF + nC+nV;
327:         (*cone)[3] = cx*nyF + cy + nC+nV+nXF;
328:         SETERRQ(PETSC_COMM_SELF, PETSC_ERR_SUP, "Too lazy to do cell cones");
329:       } else if (p < nC+nV) {
330:       } else if (p < nC+nV+nXF) {
331:         const PetscInt fy = (p - nC+nV) / nxF;
332:         const PetscInt fx = (p - nC+nV) % nxF;

334:         (*cone)[0] = fy*nVx + fx + nC;
335:         (*cone)[1] = fy*nVx + fx + 1 + nC;
336:       } else if (p < nC+nV+nXF+nYF) {
337:         const PetscInt fx = (p - nC+nV+nXF) / nyF;
338:         const PetscInt fy = (p - nC+nV+nXF) % nyF;

340:         (*cone)[0] = fy*nVx + fx + nC;
341:         (*cone)[1] = fy*nVx + fx + nVx + nC;
342:       } else SETERRQ2(PETSC_COMM_SELF, PETSC_ERR_ARG_OUTOFRANGE, "Point %d should be in [0, %d)", p, nC+nV+nXF+nYF+nZF);
343:     } else SETERRQ1(PETSC_COMM_SELF, PETSC_ERR_ARG_OUTOFRANGE, "Negative point %d is invalid", p);
344:     break;
345:   case 3:
346:     SETERRQ(PETSC_COMM_SELF, PETSC_ERR_SUP, "Too lazy to do 3D");
347:   }
348:   return(0);
349: }

351: PetscErrorCode DMDARestoreCone(DM dm, PetscInt p, PetscInt *cone[])
352: {

356:   DMGetWorkArray(dm, 6, MPIU_INT, cone);
357:   return(0);
358: }

360: PetscErrorCode DMDASetVertexCoordinates(DM dm, PetscReal xl, PetscReal xu, PetscReal yl, PetscReal yu, PetscReal zl, PetscReal zu)
361: {
362:   DM_DA         *da = (DM_DA *) dm->data;
363:   Vec            coordinates;
364:   PetscSection   section;
365:   PetscScalar   *coords;
366:   PetscReal      h[3];
367:   PetscInt       dim, size, M, N, P, nVx, nVy, nVz, nV, vStart, vEnd, v, i, j, k;

372:   DMDAGetInfo(dm, &dim, &M, &N, &P, NULL, NULL, NULL, NULL, NULL, NULL, NULL, NULL, NULL);
373:   if (dim > 3) SETERRQ(PetscObjectComm((PetscObject)dm),PETSC_ERR_PLIB,"The following code only works for dim <= 3");
374:   h[0] = (xu - xl)/M;
375:   h[1] = (yu - yl)/N;
376:   h[2] = (zu - zl)/P;
377:   DMDAGetDepthStratum(dm, 0, &vStart, &vEnd);
378:   DMDAGetNumVertices(dm, &nVx, &nVy, &nVz, &nV);
379:   PetscSectionCreate(PetscObjectComm((PetscObject) dm), &section);
380:   PetscSectionSetNumFields(section, 1);
381:   PetscSectionSetFieldComponents(section, 0, dim);
382:   PetscSectionSetChart(section, vStart, vEnd);
383:   for (v = vStart; v < vEnd; ++v) {
384:     PetscSectionSetDof(section, v, dim);
385:   }
386:   PetscSectionSetUp(section);
387:   PetscSectionGetStorageSize(section, &size);
388:   VecCreateSeq(PETSC_COMM_SELF, size, &coordinates);
389:   PetscObjectSetName((PetscObject)coordinates,"coordinates");
390:   VecGetArray(coordinates, &coords);
391:   for (k = 0; k < nVz; ++k) {
392:     PetscInt ind[3], d, off;

394:     ind[0] = 0;
395:     ind[1] = 0;
396:     ind[2] = k + da->zs;
397:     for (j = 0; j < nVy; ++j) {
398:       ind[1] = j + da->ys;
399:       for (i = 0; i < nVx; ++i) {
400:         const PetscInt vertex = (k*nVy + j)*nVx + i + vStart;

402:         PetscSectionGetOffset(section, vertex, &off);
403:         ind[0] = i + da->xs;
404:         for (d = 0; d < dim; ++d) {
405:           coords[off+d] = h[d]*ind[d];
406:         }
407:       }
408:     }
409:   }
410:   VecRestoreArray(coordinates, &coords);
411:   DMSetCoordinateSection(dm, PETSC_DETERMINE, section);
412:   DMSetCoordinatesLocal(dm, coordinates);
413:   PetscSectionDestroy(&section);
414:   VecDestroy(&coordinates);
415:   return(0);
416: }

418: /* ------------------------------------------------------------------- */

420: /*@C
421:      DMDAGetArray - Gets a work array for a DMDA

423:     Input Parameters:
424: +    da - information about my local patch
425: -    ghosted - do you want arrays for the ghosted or nonghosted patch

427:     Output Parameters:
428: .    vptr - array data structured

430:     Note:  The vector values are NOT initialized and may have garbage in them, so you may need
431:            to zero them.

433:   Level: advanced

435: .seealso: DMDARestoreArray()

437: @*/
438: PetscErrorCode  DMDAGetArray(DM da,PetscBool ghosted,void *vptr)
439: {
441:   PetscInt       j,i,xs,ys,xm,ym,zs,zm;
442:   char           *iarray_start;
443:   void           **iptr = (void**)vptr;
444:   DM_DA          *dd    = (DM_DA*)da->data;

448:   if (ghosted) {
449:     for (i=0; i<DMDA_MAX_WORK_ARRAYS; i++) {
450:       if (dd->arrayghostedin[i]) {
451:         *iptr                 = dd->arrayghostedin[i];
452:         iarray_start          = (char*)dd->startghostedin[i];
453:         dd->arrayghostedin[i] = NULL;
454:         dd->startghostedin[i] = NULL;

456:         goto done;
457:       }
458:     }
459:     xs = dd->Xs;
460:     ys = dd->Ys;
461:     zs = dd->Zs;
462:     xm = dd->Xe-dd->Xs;
463:     ym = dd->Ye-dd->Ys;
464:     zm = dd->Ze-dd->Zs;
465:   } else {
466:     for (i=0; i<DMDA_MAX_WORK_ARRAYS; i++) {
467:       if (dd->arrayin[i]) {
468:         *iptr          = dd->arrayin[i];
469:         iarray_start   = (char*)dd->startin[i];
470:         dd->arrayin[i] = NULL;
471:         dd->startin[i] = NULL;

473:         goto done;
474:       }
475:     }
476:     xs = dd->xs;
477:     ys = dd->ys;
478:     zs = dd->zs;
479:     xm = dd->xe-dd->xs;
480:     ym = dd->ye-dd->ys;
481:     zm = dd->ze-dd->zs;
482:   }

484:   switch (da->dim) {
485:   case 1: {
486:     void *ptr;

488:     PetscMalloc(xm*sizeof(PetscScalar),&iarray_start);

490:     ptr   = (void*)(iarray_start - xs*sizeof(PetscScalar));
491:     *iptr = (void*)ptr;
492:     break;
493:   }
494:   case 2: {
495:     void **ptr;

497:     PetscMalloc((ym+1)*sizeof(void*)+xm*ym*sizeof(PetscScalar),&iarray_start);

499:     ptr = (void**)(iarray_start + xm*ym*sizeof(PetscScalar) - ys*sizeof(void*));
500:     for (j=ys; j<ys+ym; j++) ptr[j] = iarray_start + sizeof(PetscScalar)*(xm*(j-ys) - xs);
501:     *iptr = (void*)ptr;
502:     break;
503:   }
504:   case 3: {
505:     void ***ptr,**bptr;

507:     PetscMalloc((zm+1)*sizeof(void**)+(ym*zm+1)*sizeof(void*)+xm*ym*zm*sizeof(PetscScalar),&iarray_start);

509:     ptr  = (void***)(iarray_start + xm*ym*zm*sizeof(PetscScalar) - zs*sizeof(void*));
510:     bptr = (void**)(iarray_start + xm*ym*zm*sizeof(PetscScalar) + zm*sizeof(void**));
511:     for (i=zs; i<zs+zm; i++) ptr[i] = bptr + ((i-zs)*ym - ys);
512:     for (i=zs; i<zs+zm; i++) {
513:       for (j=ys; j<ys+ym; j++) {
514:         ptr[i][j] = iarray_start + sizeof(PetscScalar)*(xm*ym*(i-zs) + xm*(j-ys) - xs);
515:       }
516:     }
517:     *iptr = (void*)ptr;
518:     break;
519:   }
520:   default:
521:     SETERRQ1(PetscObjectComm((PetscObject)da),PETSC_ERR_SUP,"Dimension %D not supported",da->dim);
522:   }

524: done:
525:   /* add arrays to the checked out list */
526:   if (ghosted) {
527:     for (i=0; i<DMDA_MAX_WORK_ARRAYS; i++) {
528:       if (!dd->arrayghostedout[i]) {
529:         dd->arrayghostedout[i] = *iptr;
530:         dd->startghostedout[i] = iarray_start;
531:         break;
532:       }
533:     }
534:   } else {
535:     for (i=0; i<DMDA_MAX_WORK_ARRAYS; i++) {
536:       if (!dd->arrayout[i]) {
537:         dd->arrayout[i] = *iptr;
538:         dd->startout[i] = iarray_start;
539:         break;
540:       }
541:     }
542:   }
543:   return(0);
544: }

546: /*@C
547:      DMDARestoreArray - Restores an array of derivative types for a DMDA

549:     Input Parameters:
550: +    da - information about my local patch
551: .    ghosted - do you want arrays for the ghosted or nonghosted patch
552: -    vptr - array data structured

554:      Level: advanced

556: .seealso: DMDAGetArray()

558: @*/
559: PetscErrorCode  DMDARestoreArray(DM da,PetscBool ghosted,void *vptr)
560: {
561:   PetscInt i;
562:   void     **iptr = (void**)vptr,*iarray_start = NULL;
563:   DM_DA    *dd    = (DM_DA*)da->data;

567:   if (ghosted) {
568:     for (i=0; i<DMDA_MAX_WORK_ARRAYS; i++) {
569:       if (dd->arrayghostedout[i] == *iptr) {
570:         iarray_start           = dd->startghostedout[i];
571:         dd->arrayghostedout[i] = NULL;
572:         dd->startghostedout[i] = NULL;
573:         break;
574:       }
575:     }
576:     for (i=0; i<DMDA_MAX_WORK_ARRAYS; i++) {
577:       if (!dd->arrayghostedin[i]) {
578:         dd->arrayghostedin[i] = *iptr;
579:         dd->startghostedin[i] = iarray_start;
580:         break;
581:       }
582:     }
583:   } else {
584:     for (i=0; i<DMDA_MAX_WORK_ARRAYS; i++) {
585:       if (dd->arrayout[i] == *iptr) {
586:         iarray_start    = dd->startout[i];
587:         dd->arrayout[i] = NULL;
588:         dd->startout[i] = NULL;
589:         break;
590:       }
591:     }
592:     for (i=0; i<DMDA_MAX_WORK_ARRAYS; i++) {
593:       if (!dd->arrayin[i]) {
594:         dd->arrayin[i] = *iptr;
595:         dd->startin[i] = iarray_start;
596:         break;
597:       }
598:     }
599:   }
600:   return(0);
601: }