#define PETSCDM_DLL #include "src/dm/da/daimpl.h" /*I "petscda.h" I*/ #include "petscmat.h" /*I "petscmat.h" I*/ EXTERN PetscErrorCode DAGetColoring1d_MPIAIJ(DA,ISColoringType,ISColoring *); EXTERN PetscErrorCode DAGetColoring2d_MPIAIJ(DA,ISColoringType,ISColoring *); EXTERN PetscErrorCode DAGetColoring2d_5pt_MPIAIJ(DA,ISColoringType,ISColoring *); EXTERN PetscErrorCode DAGetColoring3d_MPIAIJ(DA,ISColoringType,ISColoring *); /* For ghost i that may be negative or greater than the upper bound this maps it into the 0:m-1 range using periodicity */ #define SetInRange(i,m) ((i < 0) ? m+i:((i >= m) ? i-m:i)) #undef __FUNCT__ #define __FUNCT__ "DASetBlockFills_Private" static PetscErrorCode DASetBlockFills_Private(PetscInt *dfill,PetscInt w,PetscInt **rfill) { PetscErrorCode ierr; PetscInt i,j,nz,*fill; PetscFunctionBegin; if (!dfill) PetscFunctionReturn(0); /* count number nonzeros */ nz = 0; for (i=0; iprealloc_only = only; PetscFunctionReturn(0); } #undef __FUNCT__ #define __FUNCT__ "DASetBlockFills" /*@ DASetBlockFills - Sets the fill pattern in each block for a multi-component problem of the matrix returned by DAGetMatrix(). Collective on DA Input Parameter: + da - the distributed array . dfill - the fill pattern in the diagonal block (may be PETSC_NULL, means use dense block) - ofill - the fill pattern in the off-diagonal blocks Level: developer Notes: This only makes sense when you are doing multicomponent problems but using the MPIAIJ matrix format The format for dfill and ofill is a 2 dimensional dof by dof matrix with 1 entries representing coupling and 0 entries for missing coupling. For example $ dfill[9] = {1, 0, 0, $ 1, 1, 0, $ 0, 1, 1} means that row 0 is coupled with only itself in the diagonal block, row 1 is coupled with itself and row 0 (in the diagonal block) and row 2 is coupled with itself and row 1 (in the diagonal block). DASetGetMatrix() allows you to provide general code for those more complicated nonzero patterns then can be represented in the dfill, ofill format Contributed by Glenn Hammond .seealso DAGetMatrix(), DASetGetMatrix(), DASetMatPreallocateOnly() @*/ PetscErrorCode PETSCDM_DLLEXPORT DASetBlockFills(DA da,PetscInt *dfill,PetscInt *ofill) { PetscErrorCode ierr; PetscFunctionBegin; ierr = DASetBlockFills_Private(dfill,da->w,&da->dfill);CHKERRQ(ierr); ierr = DASetBlockFills_Private(ofill,da->w,&da->ofill);CHKERRQ(ierr); PetscFunctionReturn(0); } #undef __FUNCT__ #define __FUNCT__ "DAGetColoring" /*@ DAGetColoring - Gets the coloring required for computing the Jacobian via finite differences on a function defined using a stencil on the DA. Collective on DA Input Parameter: + da - the distributed array - ctype - IS_COLORING_GLOBAL or IS_COLORING_GHOSTED Output Parameters: . coloring - matrix coloring for use in computing Jacobians (or PETSC_NULL if not needed) Level: advanced Notes: These compute the graph coloring of the graph of A^{T}A. The coloring used for efficient (parallel or thread based) triangular solves etc is NOT available. .seealso ISColoringView(), ISColoringGetIS(), MatFDColoringCreate(), ISColoringType, ISColoring @*/ PetscErrorCode PETSCDM_DLLEXPORT DAGetColoring(DA da,ISColoringType ctype,ISColoring *coloring) { PetscErrorCode ierr; PetscInt dim; PetscFunctionBegin; /* m ------------------------------------------------------ | | | | | ---------------------- | | | | | n | yn | | | | | | | | .--------------------- | | (xs,ys) xn | | . | | (gxs,gys) | | | ----------------------------------------------------- */ /* nc - number of components per grid point col - number of colors needed in one direction for single component problem */ ierr = DAGetInfo(da,&dim,0,0,0,0,0,0,0,0,0,0);CHKERRQ(ierr); /* We do not provide a getcoloring function in the DA operations because the basic DA does not know about matrices. We think of DA as being more more low-level then matrices. */ if (dim == 1) { ierr = DAGetColoring1d_MPIAIJ(da,ctype,coloring);CHKERRQ(ierr); } else if (dim == 2) { ierr = DAGetColoring2d_MPIAIJ(da,ctype,coloring);CHKERRQ(ierr); } else if (dim == 3) { ierr = DAGetColoring3d_MPIAIJ(da,ctype,coloring);CHKERRQ(ierr); } else { SETERRQ1(PETSC_ERR_SUP,"Not done for %D dimension, send us mail petsc-maint@mcs.anl.gov for code",dim); } PetscFunctionReturn(0); } /* ---------------------------------------------------------------------------------*/ #undef __FUNCT__ #define __FUNCT__ "DAGetColoring2d_MPIAIJ" PetscErrorCode DAGetColoring2d_MPIAIJ(DA da,ISColoringType ctype,ISColoring *coloring) { PetscErrorCode ierr; PetscInt xs,ys,nx,ny,i,j,ii,gxs,gys,gnx,gny,m,n,M,N,dim,s,k,nc,col; PetscInt ncolors; MPI_Comm comm; DAPeriodicType wrap; DAStencilType st; ISColoringValue *colors; PetscFunctionBegin; /* nc - number of components per grid point col - number of colors needed in one direction for single component problem */ ierr = DAGetInfo(da,&dim,&m,&n,0,&M,&N,0,&nc,&s,&wrap,&st);CHKERRQ(ierr); col = 2*s + 1; ierr = DAGetCorners(da,&xs,&ys,0,&nx,&ny,0);CHKERRQ(ierr); ierr = DAGetGhostCorners(da,&gxs,&gys,0,&gnx,&gny,0);CHKERRQ(ierr); ierr = PetscObjectGetComm((PetscObject)da,&comm);CHKERRQ(ierr); /* special case as taught to us by Paul Hovland */ if (st == DA_STENCIL_STAR && s == 1) { ierr = DAGetColoring2d_5pt_MPIAIJ(da,ctype,coloring);CHKERRQ(ierr); } else { if (DAXPeriodic(wrap) && (m % col)){ SETERRQ(PETSC_ERR_SUP,"For coloring efficiency ensure number of grid points in X is divisible\n\ by 2*stencil_width + 1\n"); } if (DAYPeriodic(wrap) && (n % col)){ SETERRQ(PETSC_ERR_SUP,"For coloring efficiency ensure number of grid points in Y is divisible\n\ by 2*stencil_width + 1\n"); } if (ctype == IS_COLORING_GLOBAL) { if (!da->localcoloring) { ierr = PetscMalloc(nc*nx*ny*sizeof(ISColoringValue),&colors);CHKERRQ(ierr); ii = 0; for (j=ys; jlocalcoloring);CHKERRQ(ierr); } *coloring = da->localcoloring; } else if (ctype == IS_COLORING_GHOSTED) { if (!da->ghostedcoloring) { ierr = PetscMalloc(nc*gnx*gny*sizeof(ISColoringValue),&colors);CHKERRQ(ierr); ii = 0; for (j=gys; jghostedcoloring);CHKERRQ(ierr); ierr = ISColoringSetType(da->ghostedcoloring,IS_COLORING_GHOSTED);CHKERRQ(ierr); } *coloring = da->ghostedcoloring; } else SETERRQ1(PETSC_ERR_ARG_WRONG,"Unknown ISColoringType %d",(int)ctype); } ierr = ISColoringReference(*coloring);CHKERRQ(ierr); PetscFunctionReturn(0); } /* ---------------------------------------------------------------------------------*/ #undef __FUNCT__ #define __FUNCT__ "DAGetColoring3d_MPIAIJ" PetscErrorCode DAGetColoring3d_MPIAIJ(DA da,ISColoringType ctype,ISColoring *coloring) { PetscErrorCode ierr; PetscInt xs,ys,nx,ny,i,j,gxs,gys,gnx,gny,m,n,p,dim,s,k,nc,col,zs,gzs,ii,l,nz,gnz,M,N,P; PetscInt ncolors; MPI_Comm comm; DAPeriodicType wrap; DAStencilType st; ISColoringValue *colors; PetscFunctionBegin; /* nc - number of components per grid point col - number of colors needed in one direction for single component problem */ ierr = DAGetInfo(da,&dim,&m,&n,&p,&M,&N,&P,&nc,&s,&wrap,&st);CHKERRQ(ierr); col = 2*s + 1; if (DAXPeriodic(wrap) && (m % col)){ SETERRQ(PETSC_ERR_SUP,"For coloring efficiency ensure number of grid points in X is divisible\n\ by 2*stencil_width + 1\n"); } if (DAYPeriodic(wrap) && (n % col)){ SETERRQ(PETSC_ERR_SUP,"For coloring efficiency ensure number of grid points in Y is divisible\n\ by 2*stencil_width + 1\n"); } if (DAZPeriodic(wrap) && (p % col)){ SETERRQ(PETSC_ERR_SUP,"For coloring efficiency ensure number of grid points in Z is divisible\n\ by 2*stencil_width + 1\n"); } ierr = DAGetCorners(da,&xs,&ys,&zs,&nx,&ny,&nz);CHKERRQ(ierr); ierr = DAGetGhostCorners(da,&gxs,&gys,&gzs,&gnx,&gny,&gnz);CHKERRQ(ierr); ierr = PetscObjectGetComm((PetscObject)da,&comm);CHKERRQ(ierr); /* create the coloring */ if (ctype == IS_COLORING_GLOBAL) { if (!da->localcoloring) { ierr = PetscMalloc(nc*nx*ny*nz*sizeof(ISColoringValue),&colors);CHKERRQ(ierr); ii = 0; for (k=zs; klocalcoloring);CHKERRQ(ierr); } *coloring = da->localcoloring; } else if (ctype == IS_COLORING_GHOSTED) { if (!da->ghostedcoloring) { ierr = PetscMalloc(nc*gnx*gny*gnz*sizeof(ISColoringValue),&colors);CHKERRQ(ierr); ii = 0; for (k=gzs; kghostedcoloring);CHKERRQ(ierr); ierr = ISColoringSetType(da->ghostedcoloring,IS_COLORING_GHOSTED);CHKERRQ(ierr); } *coloring = da->ghostedcoloring; } else SETERRQ1(PETSC_ERR_ARG_WRONG,"Unknown ISColoringType %d",(int)ctype); ierr = ISColoringReference(*coloring);CHKERRQ(ierr); PetscFunctionReturn(0); } /* ---------------------------------------------------------------------------------*/ #undef __FUNCT__ #define __FUNCT__ "DAGetColoring1d_MPIAIJ" PetscErrorCode DAGetColoring1d_MPIAIJ(DA da,ISColoringType ctype,ISColoring *coloring) { PetscErrorCode ierr; PetscInt xs,nx,i,i1,gxs,gnx,l,m,M,dim,s,nc,col; PetscInt ncolors; MPI_Comm comm; DAPeriodicType wrap; ISColoringValue *colors; PetscFunctionBegin; /* nc - number of components per grid point col - number of colors needed in one direction for single component problem */ ierr = DAGetInfo(da,&dim,&m,0,0,&M,0,0,&nc,&s,&wrap,0);CHKERRQ(ierr); col = 2*s + 1; if (DAXPeriodic(wrap) && (m % col)) { SETERRQ(PETSC_ERR_SUP,"For coloring efficiency ensure number of grid points is divisible\n\ by 2*stencil_width + 1\n"); } ierr = DAGetCorners(da,&xs,0,0,&nx,0,0);CHKERRQ(ierr); ierr = DAGetGhostCorners(da,&gxs,0,0,&gnx,0,0);CHKERRQ(ierr); ierr = PetscObjectGetComm((PetscObject)da,&comm);CHKERRQ(ierr); /* create the coloring */ if (ctype == IS_COLORING_GLOBAL) { if (!da->localcoloring) { ierr = PetscMalloc(nc*nx*sizeof(ISColoringValue),&colors);CHKERRQ(ierr); i1 = 0; for (i=xs; ilocalcoloring);CHKERRQ(ierr); } *coloring = da->localcoloring; } else if (ctype == IS_COLORING_GHOSTED) { if (!da->ghostedcoloring) { ierr = PetscMalloc(nc*gnx*sizeof(ISColoringValue),&colors);CHKERRQ(ierr); i1 = 0; for (i=gxs; ighostedcoloring);CHKERRQ(ierr); ierr = ISColoringSetType(da->ghostedcoloring,IS_COLORING_GHOSTED);CHKERRQ(ierr); } *coloring = da->ghostedcoloring; } else SETERRQ1(PETSC_ERR_ARG_WRONG,"Unknown ISColoringType %d",(int)ctype); ierr = ISColoringReference(*coloring);CHKERRQ(ierr); PetscFunctionReturn(0); } #undef __FUNCT__ #define __FUNCT__ "DAGetColoring2d_5pt_MPIAIJ" PetscErrorCode DAGetColoring2d_5pt_MPIAIJ(DA da,ISColoringType ctype,ISColoring *coloring) { PetscErrorCode ierr; PetscInt xs,ys,nx,ny,i,j,ii,gxs,gys,gnx,gny,m,n,dim,s,k,nc; PetscInt ncolors; MPI_Comm comm; DAPeriodicType wrap; ISColoringValue *colors; PetscFunctionBegin; /* nc - number of components per grid point col - number of colors needed in one direction for single component problem */ ierr = DAGetInfo(da,&dim,&m,&n,0,0,0,0,&nc,&s,&wrap,0);CHKERRQ(ierr); ierr = DAGetCorners(da,&xs,&ys,0,&nx,&ny,0);CHKERRQ(ierr); ierr = DAGetGhostCorners(da,&gxs,&gys,0,&gnx,&gny,0);CHKERRQ(ierr); ierr = PetscObjectGetComm((PetscObject)da,&comm);CHKERRQ(ierr); if (DAXPeriodic(wrap) && (m % 5)){ SETERRQ(PETSC_ERR_SUP,"For coloring efficiency ensure number of grid points in X is divisible\n\ by 5\n"); } if (DAYPeriodic(wrap) && (n % 5)){ SETERRQ(PETSC_ERR_SUP,"For coloring efficiency ensure number of grid points in Y is divisible\n\ by 5\n"); } /* create the coloring */ if (ctype == IS_COLORING_GLOBAL) { if (!da->localcoloring) { ierr = PetscMalloc(nc*nx*ny*sizeof(ISColoringValue),&colors);CHKERRQ(ierr); ii = 0; for (j=ys; jlocalcoloring);CHKERRQ(ierr); } *coloring = da->localcoloring; } else if (ctype == IS_COLORING_GHOSTED) { if (!da->ghostedcoloring) { ierr = PetscMalloc(nc*gnx*gny*sizeof(ISColoringValue),&colors);CHKERRQ(ierr); ii = 0; for (j=gys; jghostedcoloring);CHKERRQ(ierr); ierr = ISColoringSetType(da->ghostedcoloring,IS_COLORING_GHOSTED);CHKERRQ(ierr); } *coloring = da->ghostedcoloring; } else SETERRQ1(PETSC_ERR_ARG_WRONG,"Unknown ISColoringType %d",(int)ctype); PetscFunctionReturn(0); } /* =========================================================================== */ EXTERN PetscErrorCode DAGetMatrix1d_MPIAIJ(DA,Mat); EXTERN PetscErrorCode DAGetMatrix2d_MPIAIJ(DA,Mat); EXTERN PetscErrorCode DAGetMatrix2d_MPIAIJ_Fill(DA,Mat); EXTERN PetscErrorCode DAGetMatrix3d_MPIAIJ(DA,Mat); EXTERN PetscErrorCode DAGetMatrix3d_MPIAIJ_Fill(DA,Mat); EXTERN PetscErrorCode DAGetMatrix2d_MPIBAIJ(DA,Mat); EXTERN PetscErrorCode DAGetMatrix3d_MPIBAIJ(DA,Mat); EXTERN PetscErrorCode DAGetMatrix2d_MPISBAIJ(DA,Mat); EXTERN PetscErrorCode DAGetMatrix3d_MPISBAIJ(DA,Mat); #undef __FUNCT__ #define __FUNCT__ "DAGetMatrix" /*@C DAGetMatrix - Creates a matrix with the correct parallel layout and nonzero structure required for computing the Jacobian on a function defined using the stencil set in the DA. Collective on DA Input Parameter: + da - the distributed array - mtype - Supported types are MATSEQAIJ, MATMPIAIJ, MATSEQBAIJ, MATMPIBAIJ, MATSEQSBAIJ, MATMPISBAIJ, or any type which inherits from one of these (such as MATAIJ, MATLUSOL, etc.). Output Parameters: . J - matrix with the correct nonzero structure (obviously without the correct Jacobian values) Level: advanced Notes: This properly preallocates the number of nonzeros in the sparse matrix so you do not need to do it yourself. By default it also sets the nonzero structure and puts in the zero entries. To prevent setting the nonzero pattern call DASetMatPreallocateOnly() .seealso ISColoringView(), ISColoringGetIS(), MatFDColoringCreate(), DASetBlockFills(), DASetMatPreallocateOnly() @*/ PetscErrorCode PETSCDM_DLLEXPORT DAGetMatrix(DA da, MatType mtype,Mat *J) { PetscErrorCode ierr; PetscInt dim,dof,nx,ny,nz,dims[3],starts[3]; Mat A; MPI_Comm comm; MatType Atype; void (*aij)(void)=PETSC_NULL,(*baij)(void)=PETSC_NULL,(*sbaij)(void)=PETSC_NULL; PetscFunctionBegin; /* m ------------------------------------------------------ | | | | | ---------------------- | | | | | n | ny | | | | | | | | .--------------------- | | (xs,ys) nx | | . | | (gxs,gys) | | | ----------------------------------------------------- */ /* nc - number of components per grid point col - number of colors needed in one direction for single component problem */ ierr = DAGetInfo(da,&dim,0,0,0,0,0,0,&dof,0,0,0);CHKERRQ(ierr); ierr = DAGetCorners(da,0,0,0,&nx,&ny,&nz);CHKERRQ(ierr); ierr = PetscObjectGetComm((PetscObject)da,&comm);CHKERRQ(ierr); ierr = MatCreate(comm,&A);CHKERRQ(ierr); ierr = MatSetSizes(A,dof*nx*ny*nz,dof*nx*ny*nz,PETSC_DECIDE,PETSC_DECIDE);CHKERRQ(ierr); ierr = MatSetType(A,mtype);CHKERRQ(ierr); ierr = MatSetFromOptions(A);CHKERRQ(ierr); ierr = MatGetType(A,&Atype);CHKERRQ(ierr); /* We do not provide a getmatrix function in the DA operations because the basic DA does not know about matrices. We think of DA as being more more low-level than matrices. This is kind of cheating but, cause sometimes we think of DA has higher level than matrices. We could switch based on Atype (or mtype), but we do not since the specialized setting routines depend only the particular preallocation details of the matrix, not the type itself. */ ierr = PetscObjectQueryFunction((PetscObject)A,"MatMPIAIJSetPreallocation_C",&aij);CHKERRQ(ierr); if (!aij) { ierr = PetscObjectQueryFunction((PetscObject)A,"MatSeqAIJSetPreallocation_C",&aij);CHKERRQ(ierr); } if (!aij) { ierr = PetscObjectQueryFunction((PetscObject)A,"MatMPIBAIJSetPreallocation_C",&baij);CHKERRQ(ierr); if (!baij) { ierr = PetscObjectQueryFunction((PetscObject)A,"MatSeqBAIJSetPreallocation_C",&baij);CHKERRQ(ierr); } if (!baij){ ierr = PetscObjectQueryFunction((PetscObject)A,"MatMPISBAIJSetPreallocation_C",&sbaij);CHKERRQ(ierr); if (!sbaij) { ierr = PetscObjectQueryFunction((PetscObject)A,"MatSeqSBAIJSetPreallocation_C",&sbaij);CHKERRQ(ierr); } if (!sbaij) SETERRQ2(PETSC_ERR_SUP,"Not implemented for the matrix type: %s!\n" \ "Send mail to petsc-maint@mcs.anl.gov for code",dim,Atype); } } if (aij) { if (dim == 1) { ierr = DAGetMatrix1d_MPIAIJ(da,A);CHKERRQ(ierr); } else if (dim == 2) { if (da->ofill) { DAGetMatrix2d_MPIAIJ_Fill(da,A);CHKERRQ(ierr); } else { DAGetMatrix2d_MPIAIJ(da,A);CHKERRQ(ierr); } } else if (dim == 3) { if (da->ofill) { DAGetMatrix3d_MPIAIJ_Fill(da,A);CHKERRQ(ierr); } else { DAGetMatrix3d_MPIAIJ(da,A);CHKERRQ(ierr); } } } else if (baij) { if (dim == 2) { ierr = DAGetMatrix2d_MPIBAIJ(da,A);CHKERRQ(ierr); } else if (dim == 3) { ierr = DAGetMatrix3d_MPIBAIJ(da,A);CHKERRQ(ierr); } else { SETERRQ2(PETSC_ERR_SUP,"Not implemented for %D dimension and Matrix Type: %s!\n" \ "Send mail to petsc-maint@mcs.anl.gov for code",dim,Atype); } } else if (sbaij) { if (dim == 2) { ierr = DAGetMatrix2d_MPISBAIJ(da,A);CHKERRQ(ierr); } else if (dim == 3) { ierr = DAGetMatrix3d_MPISBAIJ(da,A);CHKERRQ(ierr); } else { SETERRQ2(PETSC_ERR_SUP,"Not implemented for %D dimension and Matrix Type: %s!\n" \ "Send mail to petsc-maint@mcs.anl.gov for code",dim,Atype); } } ierr = DAGetGhostCorners(da,&starts[0],&starts[1],&starts[2],&dims[0],&dims[1],&dims[2]);CHKERRQ(ierr); ierr = MatSetStencil(A,dim,dims,starts,dof);CHKERRQ(ierr); *J = A; PetscFunctionReturn(0); } /* ---------------------------------------------------------------------------------*/ #undef __FUNCT__ #define __FUNCT__ "DAGetMatrix2d_MPIAIJ" PetscErrorCode DAGetMatrix2d_MPIAIJ(DA da,Mat J) { PetscErrorCode ierr; PetscInt xs,ys,nx,ny,i,j,slot,gxs,gys,gnx,gny,m,n,dim,s,*cols = PETSC_NULL,k,nc,*rows = PETSC_NULL,col,cnt,l,p; PetscInt lstart,lend,pstart,pend,*dnz,*onz; MPI_Comm comm; PetscScalar *values; DAPeriodicType wrap; ISLocalToGlobalMapping ltog; DAStencilType st; PetscFunctionBegin; /* nc - number of components per grid point col - number of colors needed in one direction for single component problem */ ierr = DAGetInfo(da,&dim,&m,&n,0,0,0,0,&nc,&s,&wrap,&st);CHKERRQ(ierr); col = 2*s + 1; ierr = DAGetCorners(da,&xs,&ys,0,&nx,&ny,0);CHKERRQ(ierr); ierr = DAGetGhostCorners(da,&gxs,&gys,0,&gnx,&gny,0);CHKERRQ(ierr); ierr = PetscObjectGetComm((PetscObject)da,&comm);CHKERRQ(ierr); ierr = PetscMalloc2(nc,PetscInt,&rows,col*col*nc*nc,PetscInt,&cols);CHKERRQ(ierr); ierr = DAGetISLocalToGlobalMapping(da,<og);CHKERRQ(ierr); /* determine the matrix preallocation information */ ierr = MatPreallocateInitialize(comm,nc*nx*ny,nc*nx*ny,dnz,onz);CHKERRQ(ierr); for (i=xs; iprealloc_only) { ierr = PetscMalloc(col*col*nc*nc*sizeof(PetscScalar),&values);CHKERRQ(ierr); ierr = PetscMemzero(values,col*col*nc*nc*sizeof(PetscScalar));CHKERRQ(ierr); for (i=xs; iofill, *dfill = da->dfill; MPI_Comm comm; PetscScalar *values; DAPeriodicType wrap; ISLocalToGlobalMapping ltog; DAStencilType st; PetscFunctionBegin; /* nc - number of components per grid point col - number of colors needed in one direction for single component problem */ ierr = DAGetInfo(da,&dim,&m,&n,0,0,0,0,&nc,&s,&wrap,&st);CHKERRQ(ierr); col = 2*s + 1; ierr = DAGetCorners(da,&xs,&ys,0,&nx,&ny,0);CHKERRQ(ierr); ierr = DAGetGhostCorners(da,&gxs,&gys,0,&gnx,&gny,0);CHKERRQ(ierr); ierr = PetscObjectGetComm((PetscObject)da,&comm);CHKERRQ(ierr); ierr = PetscMalloc(col*col*nc*nc*sizeof(PetscInt),&cols);CHKERRQ(ierr); ierr = DAGetISLocalToGlobalMapping(da,<og);CHKERRQ(ierr); /* determine the matrix preallocation information */ ierr = MatPreallocateInitialize(comm,nc*nx*ny,nc*nx*ny,dnz,onz);CHKERRQ(ierr); for (i=xs; iprealloc_only) { ierr = PetscMalloc(col*col*nc*nc*sizeof(PetscScalar),&values);CHKERRQ(ierr); ierr = PetscMemzero(values,col*col*nc*nc*sizeof(PetscScalar));CHKERRQ(ierr); for (i=xs; iprealloc_only) { ierr = PetscMalloc(col*col*col*nc*nc*nc*sizeof(PetscScalar),&values);CHKERRQ(ierr); ierr = PetscMemzero(values,col*col*col*nc*nc*nc*sizeof(PetscScalar));CHKERRQ(ierr); for (i=xs; iprealloc_only) { ierr = PetscMalloc(col*nc*nc*sizeof(PetscScalar),&values);CHKERRQ(ierr); ierr = PetscMemzero(values,col*nc*nc*sizeof(PetscScalar));CHKERRQ(ierr); for (i=xs; iprealloc_only) { ierr = PetscMalloc(col*col*nc*nc*sizeof(PetscScalar),&values);CHKERRQ(ierr); ierr = PetscMemzero(values,col*col*nc*nc*sizeof(PetscScalar));CHKERRQ(ierr); for (i=xs; iprealloc_only) { ierr = PetscMalloc(col*col*col*nc*nc*sizeof(PetscScalar),&values);CHKERRQ(ierr); ierr = PetscMemzero(values,col*col*col*nc*nc*sizeof(PetscScalar));CHKERRQ(ierr); for (i=xs; iprealloc_only) { ierr = PetscMalloc(col*col*nc*nc*sizeof(PetscScalar),&values);CHKERRQ(ierr); ierr = PetscMemzero(values,col*col*nc*nc*sizeof(PetscScalar));CHKERRQ(ierr); for (i=xs; iprealloc_only) { ierr = PetscMalloc(col*col*col*nc*nc*sizeof(PetscScalar),&values);CHKERRQ(ierr); ierr = PetscMemzero(values,col*col*col*nc*nc*sizeof(PetscScalar));CHKERRQ(ierr); for (i=xs; idfill,*ofill = da->ofill; MPI_Comm comm; PetscScalar *values; DAPeriodicType wrap; ISLocalToGlobalMapping ltog; DAStencilType st; PetscFunctionBegin; /* nc - number of components per grid point col - number of colors needed in one direction for single component problem */ ierr = DAGetInfo(da,&dim,&m,&n,&p,0,0,0,&nc,&s,&wrap,&st);CHKERRQ(ierr); col = 2*s + 1; if (DAXPeriodic(wrap) && (m % col)){ SETERRQ(PETSC_ERR_SUP,"For coloring efficiency ensure number of grid points in X is divisible\n\ by 2*stencil_width + 1\n"); } if (DAYPeriodic(wrap) && (n % col)){ SETERRQ(PETSC_ERR_SUP,"For coloring efficiency ensure number of grid points in Y is divisible\n\ by 2*stencil_width + 1\n"); } if (DAZPeriodic(wrap) && (p % col)){ SETERRQ(PETSC_ERR_SUP,"For coloring efficiency ensure number of grid points in Z is divisible\n\ by 2*stencil_width + 1\n"); } ierr = DAGetCorners(da,&xs,&ys,&zs,&nx,&ny,&nz);CHKERRQ(ierr); ierr = DAGetGhostCorners(da,&gxs,&gys,&gzs,&gnx,&gny,&gnz);CHKERRQ(ierr); ierr = PetscObjectGetComm((PetscObject)da,&comm);CHKERRQ(ierr); ierr = PetscMalloc(col*col*col*nc*sizeof(PetscInt),&cols);CHKERRQ(ierr); ierr = DAGetISLocalToGlobalMapping(da,<og);CHKERRQ(ierr); /* determine the matrix preallocation information */ ierr = MatPreallocateInitialize(comm,nc*nx*ny*nz,nc*nx*ny*nz,dnz,onz);CHKERRQ(ierr); for (i=xs; iprealloc_only) { ierr = PetscMalloc(col*col*col*nc*nc*nc*sizeof(PetscScalar),&values);CHKERRQ(ierr); ierr = PetscMemzero(values,col*col*col*nc*nc*nc*sizeof(PetscScalar));CHKERRQ(ierr); for (i=xs; i