/*@ DMPlexTSComputeBoundary - Insert the essential boundary values for the local input X and/or its time derivative X_t using pointwise functions specified by the user Input Parameters: + dm - The mesh . t - The time . locX - Local solution . locX_t - Local solution time derivative, or NULL - user - The user context Level: developer .seealso: DMPlexComputeJacobianActionFEM() @*/ PetscErrorCode DMPlexTSComputeBoundary(DM dm, PetscReal time, Vec locX, Vec locX_t, void *user) { DM plex; Vec faceGeometryFVM = NULL; PetscInt Nf, f; PetscErrorCode ierr; PetscFunctionBegin; ierr = DMTSConvertPlex(dm, &plex, PETSC_TRUE);CHKERRQ(ierr); ierr = DMGetNumFields(plex, &Nf);CHKERRQ(ierr); if (!locX_t) { /* This is the RHS part */ for (f = 0; f < Nf; f++) { PetscObject obj; PetscClassId id; ierr = DMGetField(plex, f, &obj);CHKERRQ(ierr); ierr = PetscObjectGetClassId(obj, &id);CHKERRQ(ierr); if (id == PETSCFV_CLASSID) { ierr = DMPlexSNESGetGeometryFVM(plex, &faceGeometryFVM, NULL, NULL);CHKERRQ(ierr); break; } } } ierr = DMPlexInsertBoundaryValues(plex, PETSC_TRUE, locX, time, faceGeometryFVM, NULL, NULL);CHKERRQ(ierr); /* TODO: locX_t */ ierr = DMDestroy(&plex);CHKERRQ(ierr); PetscFunctionReturn(0); }
static PetscErrorCode ComputeSpectral(DM dm, Vec u, PetscInt numPlanes, const PetscInt planeDir[], const PetscReal planeCoord[], AppCtx *user) { MPI_Comm comm; PetscSection coordSection, section; Vec coordinates, uloc; const PetscScalar *coords, *array; PetscInt p; PetscMPIInt size, rank; PetscErrorCode ierr; PetscFunctionBeginUser; ierr = PetscObjectGetComm((PetscObject) dm, &comm);CHKERRQ(ierr); ierr = MPI_Comm_size(comm, &size);CHKERRQ(ierr); ierr = MPI_Comm_rank(comm, &rank);CHKERRQ(ierr); ierr = DMGetLocalVector(dm, &uloc);CHKERRQ(ierr); ierr = DMGlobalToLocalBegin(dm, u, INSERT_VALUES, uloc);CHKERRQ(ierr); ierr = DMGlobalToLocalEnd(dm, u, INSERT_VALUES, uloc);CHKERRQ(ierr); ierr = DMPlexInsertBoundaryValues(dm, PETSC_TRUE, uloc, 0.0, NULL, NULL, NULL);CHKERRQ(ierr); ierr = VecViewFromOptions(uloc, NULL, "-sol_view");CHKERRQ(ierr); ierr = DMGetDefaultSection(dm, §ion);CHKERRQ(ierr); ierr = VecGetArrayRead(uloc, &array);CHKERRQ(ierr); ierr = DMGetCoordinatesLocal(dm, &coordinates);CHKERRQ(ierr); ierr = DMGetCoordinateSection(dm, &coordSection);CHKERRQ(ierr); ierr = VecGetArrayRead(coordinates, &coords);CHKERRQ(ierr); for (p = 0; p < numPlanes; ++p) { DMLabel label; char name[PETSC_MAX_PATH_LEN]; Mat F; Vec x, y; IS stratum; PetscReal *ray, *gray; PetscScalar *rvals, *svals, *gsvals; PetscInt *perm, *nperm; PetscInt n, N, i, j, off, offu; const PetscInt *points; ierr = PetscSNPrintf(name, PETSC_MAX_PATH_LEN, "spectral_plane_%D", p);CHKERRQ(ierr); ierr = DMGetLabel(dm, name, &label);CHKERRQ(ierr); ierr = DMLabelGetStratumIS(label, 1, &stratum);CHKERRQ(ierr); ierr = ISGetLocalSize(stratum, &n);CHKERRQ(ierr); ierr = ISGetIndices(stratum, &points);CHKERRQ(ierr); ierr = PetscMalloc2(n, &ray, n, &svals);CHKERRQ(ierr); for (i = 0; i < n; ++i) { ierr = PetscSectionGetOffset(coordSection, points[i], &off);CHKERRQ(ierr); ierr = PetscSectionGetOffset(section, points[i], &offu);CHKERRQ(ierr); ray[i] = PetscRealPart(coords[off+((planeDir[p]+1)%2)]); svals[i] = array[offu]; } /* Gather the ray data to proc 0 */ if (size > 1) { PetscMPIInt *cnt, *displs, p; ierr = PetscCalloc2(size, &cnt, size, &displs);CHKERRQ(ierr); ierr = MPI_Gather(&n, 1, MPIU_INT, cnt, 1, MPIU_INT, 0, comm);CHKERRQ(ierr); for (p = 1; p < size; ++p) displs[p] = displs[p-1] + cnt[p-1]; N = displs[size-1] + cnt[size-1]; ierr = PetscMalloc2(N, &gray, N, &gsvals);CHKERRQ(ierr); ierr = MPI_Gatherv(ray, n, MPIU_REAL, gray, cnt, displs, MPIU_REAL, 0, comm);CHKERRQ(ierr); ierr = MPI_Gatherv(svals, n, MPIU_SCALAR, gsvals, cnt, displs, MPIU_SCALAR, 0, comm);CHKERRQ(ierr); ierr = PetscFree2(cnt, displs);CHKERRQ(ierr); } else { N = n; gray = ray; gsvals = svals; } if (!rank) { /* Sort point along ray */ ierr = PetscMalloc2(N, &perm, N, &nperm);CHKERRQ(ierr); for (i = 0; i < N; ++i) {perm[i] = i;} ierr = PetscSortRealWithPermutation(N, gray, perm);CHKERRQ(ierr); /* Count duplicates and squish mapping */ nperm[0] = perm[0]; for (i = 1, j = 1; i < N; ++i) { if (PetscAbsReal(gray[perm[i]] - gray[perm[i-1]]) > PETSC_SMALL) nperm[j++] = perm[i]; } /* Create FFT structs */ ierr = MatCreateFFT(PETSC_COMM_SELF, 1, &j, MATFFTW, &F);CHKERRQ(ierr); ierr = MatCreateVecs(F, &x, &y);CHKERRQ(ierr); ierr = PetscObjectSetName((PetscObject) y, name);CHKERRQ(ierr); ierr = VecGetArray(x, &rvals);CHKERRQ(ierr); for (i = 0, j = 0; i < N; ++i) { if (i > 0 && PetscAbsReal(gray[perm[i]] - gray[perm[i-1]]) < PETSC_SMALL) continue; rvals[j] = gsvals[nperm[j]]; ++j; } ierr = PetscFree2(perm, nperm);CHKERRQ(ierr); if (size > 1) {ierr = PetscFree2(gray, gsvals);CHKERRQ(ierr);} ierr = VecRestoreArray(x, &rvals);CHKERRQ(ierr); /* Do FFT along the ray */ ierr = MatMult(F, x, y);CHKERRQ(ierr); /* Chop FFT */ ierr = VecChop(y, PETSC_SMALL);CHKERRQ(ierr); ierr = VecViewFromOptions(x, NULL, "-real_view");CHKERRQ(ierr); ierr = VecViewFromOptions(y, NULL, "-fft_view");CHKERRQ(ierr); ierr = VecDestroy(&x);CHKERRQ(ierr); ierr = VecDestroy(&y);CHKERRQ(ierr); ierr = MatDestroy(&F);CHKERRQ(ierr); } ierr = ISRestoreIndices(stratum, &points);CHKERRQ(ierr); ierr = ISDestroy(&stratum);CHKERRQ(ierr); ierr = PetscFree2(ray, svals);CHKERRQ(ierr); } ierr = VecRestoreArrayRead(coordinates, &coords);CHKERRQ(ierr); ierr = VecRestoreArrayRead(uloc, &array);CHKERRQ(ierr); ierr = DMRestoreLocalVector(dm, &uloc);CHKERRQ(ierr); PetscFunctionReturn(0); }