Actual source code: ex12.c
1: static char help[] = "Test DMStag 2d star stencil\n\n";
2: #include <petscdm.h>
3: #include <petscdmstag.h>
5: int main(int argc, char **argv)
6: {
7: DM dm;
8: Vec vec, vecLocal1, vecLocal2;
9: PetscScalar *a, ***a1, ***a2, expected, sum;
10: PetscInt startx, starty, nx, ny, i, j, d, is, js, dof0, dof1, dof2, dofTotal, stencilWidth, ngx, ngy;
11: DMBoundaryType boundaryTypex, boundaryTypey;
12: PetscMPIInt rank;
15: PetscInitialize(&argc, &argv, (char *)0, help);
16: MPI_Comm_rank(PETSC_COMM_WORLD, &rank);
17: dof0 = 1;
18: dof1 = 1;
19: dof2 = 1;
20: stencilWidth = 2;
21: DMStagCreate2d(PETSC_COMM_WORLD, DM_BOUNDARY_PERIODIC, DM_BOUNDARY_PERIODIC, 4, 4, PETSC_DECIDE, PETSC_DECIDE, dof0, dof1, dof2, DMSTAG_STENCIL_STAR, stencilWidth, NULL, NULL, &dm);
22: DMSetFromOptions(dm);
23: DMSetUp(dm);
24: DMStagGetDOF(dm, &dof0, &dof1, &dof2, NULL);
25: dofTotal = dof0 + 2 * dof1 + dof2;
26: DMStagGetStencilWidth(dm, &stencilWidth);
28: DMCreateLocalVector(dm, &vecLocal1);
29: VecDuplicate(vecLocal1, &vecLocal2);
31: DMCreateGlobalVector(dm, &vec);
32: VecSet(vec, 1.0);
33: VecSet(vecLocal1, 0.0);
34: DMGlobalToLocalBegin(dm, vec, INSERT_VALUES, vecLocal1);
35: DMGlobalToLocalEnd(dm, vec, INSERT_VALUES, vecLocal1);
37: DMStagGetCorners(dm, &startx, &starty, NULL, &nx, &ny, NULL, NULL, NULL, NULL);
38: DMStagVecGetArrayRead(dm, vecLocal1, &a1);
39: DMStagVecGetArray(dm, vecLocal2, &a2);
40: for (j = starty; j < starty + ny; ++j) {
41: for (i = startx; i < startx + nx; ++i) {
42: for (d = 0; d < dofTotal; ++d) {
43: if (a1[j][i][d] != 1.0) PetscPrintf(PETSC_COMM_SELF, "[%d] Unexpected value %g (expecting %g)\n", rank, (double)PetscRealPart(a1[j][i][d]), 1.0);
44: a2[j][i][d] = 0.0;
45: for (js = -stencilWidth; js <= stencilWidth; ++js) a2[j][i][d] += a1[j + js][i][d];
46: for (is = -stencilWidth; is <= stencilWidth; ++is) a2[j][i][d] += a1[j][i + is][d];
47: a2[j][i][d] -= a1[j][i][d];
48: }
49: }
50: }
51: DMStagVecRestoreArrayRead(dm, vecLocal1, &a1);
52: DMStagVecRestoreArray(dm, vecLocal2, &a2);
54: DMLocalToGlobalBegin(dm, vecLocal2, INSERT_VALUES, vec);
55: DMLocalToGlobalEnd(dm, vecLocal2, INSERT_VALUES, vec);
57: /* For the all-periodic case, some additional checks */
58: DMStagGetBoundaryTypes(dm, &boundaryTypex, &boundaryTypey, NULL);
59: if (boundaryTypex == DM_BOUNDARY_PERIODIC && boundaryTypey == DM_BOUNDARY_PERIODIC) {
60: DMStagGetGhostCorners(dm, NULL, NULL, NULL, &ngx, &ngy, NULL);
61: expected = (ngx * ngy - 4 * stencilWidth * stencilWidth) * dofTotal;
62: VecSum(vecLocal1, &sum);
63: if (sum != expected) PetscPrintf(PETSC_COMM_SELF, "[%d] Unexpected sum of local entries %g (expected %g)\n", rank, (double)PetscRealPart(sum), (double)PetscRealPart(expected));
65: VecGetArray(vec, &a);
66: expected = 1 + 4 * stencilWidth;
67: for (i = 0; i < ny * nx * dofTotal; ++i) {
68: if (a[i] != expected) PetscPrintf(PETSC_COMM_SELF, "[%d] Unexpected value %g (expecting %g)\n", rank, (double)PetscRealPart(a[i]), (double)PetscRealPart(expected));
69: }
70: VecRestoreArray(vec, &a);
71: }
73: VecDestroy(&vec);
74: VecDestroy(&vecLocal1);
75: VecDestroy(&vecLocal2);
76: DMDestroy(&dm);
77: PetscFinalize();
78: return 0;
79: }
81: /*TEST
83: test:
84: suffix: 1
85: nsize: 4
86: args: -stag_ranks_x 2 -stag_ranks_y 2 -stag_stencil_width 1
88: test:
89: suffix: 2
90: nsize: 6
91: args: -stag_ranks_x 3 -stag_ranks_y 2 -stag_dof_0 2 -stag_grid_x 6
93: test:
94: suffix: 3
95: nsize: 4
96: args: -stag_dof_0 3 -stag_dof_1 2 -stag_dof_2 4 2 -stag_stencil_width 3 -stag_grid_x 6 -stag_grid_y 6
98: test:
99: suffix: 4
100: nsize: 4
101: args: -stag_stencil_width 1 -stag_grid_x 2 -stag_grid_y 2 -stag_boundary_type_x ghosted
103: test:
104: suffix: 5
105: nsize: 4
106: args: -stag_stencil_width 1 -stag_grid_x 2 -stag_grid_y 2 -stag_boundary_type_y ghosted
108: test:
109: suffix: 6
110: nsize: 4
111: args: -stag_stencil_width 1 -stag_grid_x 3 -stag_grid_y 2 -stag_boundary_type_x ghosted -stag_boundary_type_y ghosted
113: test:
114: suffix: 7
115: nsize: 4
116: args: -stag_stencil_width 1 -stag_grid_x 2 -stag_grid_y 2 -stag_boundary_type_y ghosted
118: test:
119: suffix: 8
120: nsize: 6
121: args: -stag_stencil_width 1 -stag_grid_y 2 -stag_grid_x 19 -stag_boundary_type_y ghosted -stag_ranks_x 6
122: TEST*/