Actual source code: ex21.c

  1: static const char help[] = "Test DMCreateInjection() for mapping coordinates in 3D";

  3: #include <petscvec.h>
  4: #include <petscmat.h>
  5: #include <petscdm.h>
  6: #include <petscdmda.h>

  8: PetscErrorCode test1_DAInjection3d(PetscInt mx, PetscInt my, PetscInt mz)
  9: {
 10:   PetscErrorCode   ierr;
 11:   DM               dac,daf;
 12:   PetscViewer      vv;
 13:   Vec              ac,af;
 14:   PetscInt         periodicity;
 15:   DMBoundaryType   bx,by,bz;

 18:   bx = DM_BOUNDARY_NONE;
 19:   by = DM_BOUNDARY_NONE;
 20:   bz = DM_BOUNDARY_NONE;

 22:   periodicity = 0;

 24:   PetscOptionsGetInt(NULL,NULL,"-periodic", &periodicity, NULL);
 25:   if (periodicity==1) {
 26:     bx = DM_BOUNDARY_PERIODIC;
 27:   } else if (periodicity==2) {
 28:     by = DM_BOUNDARY_PERIODIC;
 29:   } else if (periodicity==3) {
 30:     bz = DM_BOUNDARY_PERIODIC;
 31:   }

 33:   DMDACreate3d(PETSC_COMM_WORLD, bx,by,bz, DMDA_STENCIL_BOX,mx+1, my+1,mz+1,PETSC_DECIDE, PETSC_DECIDE,PETSC_DECIDE,1, /* 1 dof */
 34:                       1, /* stencil = 1 */NULL,NULL,NULL,&daf);
 35:   DMSetFromOptions(daf);
 36:   DMSetUp(daf);

 38:   DMCoarsen(daf,MPI_COMM_NULL,&dac);

 40:   DMDASetUniformCoordinates(dac, -1.0,1.0, -1.0,1.0, -1.0,1.0);
 41:   DMDASetUniformCoordinates(daf, -1.0,1.0, -1.0,1.0, -1.0,1.0);

 43:   {
 44:     DM         cdaf,cdac;
 45:     Vec        coordsc,coordsf,coordsf2;
 46:     Mat        inject;
 47:     VecScatter vscat;
 48:     Mat        interp;
 49:     PetscReal  norm;

 51:     DMGetCoordinateDM(dac,&cdac);
 52:     DMGetCoordinateDM(daf,&cdaf);

 54:     DMGetCoordinates(dac,&coordsc);
 55:     DMGetCoordinates(daf,&coordsf);

 57:     DMCreateInjection(cdac,cdaf,&inject);
 58:     MatScatterGetVecScatter(inject,&vscat);
 59:     VecScatterBegin(vscat,coordsf,coordsc,INSERT_VALUES,SCATTER_FORWARD);
 60:     VecScatterEnd(vscat  ,coordsf,coordsc,INSERT_VALUES,SCATTER_FORWARD);
 61:     MatDestroy(&inject);

 63:     DMCreateInterpolation(cdac,cdaf,&interp,NULL);
 64:     VecDuplicate(coordsf,&coordsf2);
 65:     MatInterpolate(interp,coordsc,coordsf2);
 66:     VecAXPY(coordsf2,-1.0,coordsf);
 67:     VecNorm(coordsf2,NORM_MAX,&norm);
 68:     /* The fine coordinates are only reproduced in certain cases */
 69:     if (!bx && !by && !bz && norm > PETSC_SQRT_MACHINE_EPSILON) PetscPrintf(PETSC_COMM_WORLD,"Norm %g\n",(double)norm);
 70:     VecDestroy(&coordsf2);
 71:     MatDestroy(&interp);
 72:   }

 74:   if (0) {
 75:     DMCreateGlobalVector(dac,&ac);
 76:     VecZeroEntries(ac);

 78:     DMCreateGlobalVector(daf,&af);
 79:     VecZeroEntries(af);

 81:     PetscViewerASCIIOpen(PETSC_COMM_WORLD, "dac_7.vtu", &vv);
 82:     VecView(ac, vv);
 83:     PetscViewerDestroy(&vv);

 85:     PetscViewerASCIIOpen(PETSC_COMM_WORLD, "daf_7.vtu", &vv);
 86:     VecView(af, vv);
 87:     PetscViewerDestroy(&vv);
 88:     VecDestroy(&ac);
 89:     VecDestroy(&af);
 90:   }
 91:   DMDestroy(&dac);
 92:   DMDestroy(&daf);
 93:   return 0;
 94: }

 96: int main(int argc,char **argv)
 97: {
 98:   PetscInt       mx,my,mz;

100:   PetscInitialize(&argc,&argv,0,help);
101:   mx   = 2;
102:   my   = 2;
103:   mz   = 2;
104:   PetscOptionsGetInt(NULL,NULL,"-mx", &mx, 0);
105:   PetscOptionsGetInt(NULL,NULL,"-my", &my, 0);
106:   PetscOptionsGetInt(NULL,NULL,"-mz", &mz, 0);
107:   test1_DAInjection3d(mx,my,mz);
108:   PetscFinalize();
109:   return 0;
110: }

112: /*TEST

114:       test:
115:          nsize: 5
116:          args: -mx 30 -my 30 -mz 30 -periodic 0 -da_processors_x 5

118:       test:
119:          suffix: 2
120:          nsize: 5
121:          args: -mx 29 -my 30 -mz 30 -periodic 1 -da_processors_x 5

123:       test:
124:          suffix: 3
125:          nsize: 5
126:          args: -mx 30 -my 29 -mz 30 -periodic 2 -da_processors_x 5

128:       test:
129:          suffix: 4
130:          nsize: 5
131:          args: -mx 30 -my 30 -mz 29 -periodic 3 -da_processors_x 5

133:       test:
134:          suffix: 5
135:          nsize: 5
136:          args: -mx 30 -my 30 -mz 30 -periodic 0 -da_processors_y 5

138:       test:
139:          suffix: 6
140:          nsize: 5
141:          args: -mx 29 -my 30 -mz 30 -periodic 1 -da_processors_y 5

143:       test:
144:          suffix: 7
145:          nsize: 5
146:          args: -mx 30 -my 29 -mz 30 -periodic 2 -da_processors_y 5

148:       test:
149:          suffix: 8
150:          nsize: 5
151:          args: -mx 30 -my 30 -mz 29 -periodic 3 -da_processors_y 5

153:       test:
154:          suffix: 9
155:          nsize: 5
156:          args: -mx 30 -my 30 -mz 30 -periodic 0 -da_processors_z 5

158:       test:
159:          suffix: 10
160:          nsize: 5
161:          args: -mx 29 -my 30 -mz 30 -periodic 1 -da_processors_z 5

163:       test:
164:          suffix: 11
165:          nsize: 5
166:          args: -mx 30 -my 29 -mz 30 -periodic 2 -da_processors_z 5

168:       test:
169:          suffix: 12
170:          nsize: 5
171:          args: -mx 30 -my 30 -mz 29 -periodic 3 -da_processors_z 5

173:       test:
174:          suffix: 13
175:          nsize: 5
176:          args: -mx 30 -my 30 -mz 30 -periodic 0

178:       test:
179:          suffix: 14
180:          nsize: 5
181:          args: -mx 29 -my 30 -mz 30 -periodic 1

183:       test:
184:          suffix: 15
185:          nsize: 5
186:          args: -mx 30 -my 29 -mz 30 -periodic 2

188:       test:
189:          suffix: 16
190:          nsize: 5
191:          args: -mx 30 -my 30 -mz 29 -periodic 3

193: TEST*/