Actual source code: ex152.c

  1: static const char help[] = "Test ParMETIS handling of negative weights.\n\n";

  3: /* Test contributed by John Fettig */

  5: /*
  6:  * This file implements two tests for a bug reported in ParMETIS. These tests are not expected to pass without the
  7:  * patches in the PETSc distribution of ParMetis. See parmetis.py
  8:  *
  9:  *
 10:  * The bug was reported upstream, but has received no action so far.
 11:  *
 12:  * http://glaros.dtc.umn.edu/gkhome/node/837
 13:  *
 14:  */

 16: #include <petscsys.h>
 17: #include <parmetis.h>

 19: #define PetscCallPARMETIS(...) do {                                                              \
 20:     int metis___VA_ARGS__;                                                              \
 24:   } while (0)

 26: int main(int argc, char *argv[])
 27: {
 29:   PetscBool      flg;
 30:   PetscMPIInt    rank, size;
 31:   idx_t          ni,isize,*vtxdist, *xadj, *adjncy, *vwgt, *part;
 32:   idx_t          wgtflag=0, numflag=0, ncon=1, ndims=3, edgecut=0;
 33:   idx_t          options[5];
 34:   PetscReal      *xyz;
 35:   real_t         *sxyz, *tpwgts, ubvec[1];
 36:   MPI_Comm       comm;
 37:   FILE           *fp;
 38:   char           fname[PETSC_MAX_PATH_LEN],prefix[PETSC_MAX_PATH_LEN] = "";
 39:   size_t         red;

 41:   PetscInitialize(&argc,&argv,NULL,help);
 42: #if defined(PETSC_USE_64BIT_INDICES)
 43:   PetscPrintf(PETSC_COMM_WORLD,"This example only works with 32 bit indices\n");
 44:   PetscFinalize();
 45:   return 0;
 46: #endif
 47:   MPI_Comm_rank(PETSC_COMM_WORLD,&rank);
 48:   MPI_Comm_size(PETSC_COMM_WORLD,&size);

 50:   PetscOptionsBegin(PETSC_COMM_WORLD,NULL,"Parmetis test options","");
 51:   PetscOptionsString("-prefix","Path and prefix of test file","",prefix,prefix,sizeof(prefix),&flg);
 53:   PetscOptionsEnd();

 55:   PetscMalloc1(size+1,&vtxdist);

 57:   PetscSNPrintf(fname,sizeof(fname),"%s.%d.graph",prefix,rank);

 59:   PetscFOpen(PETSC_COMM_SELF,fname,"r",&fp);


 63:   ni = vtxdist[rank+1]-vtxdist[rank];

 65:   PetscMalloc1(ni+1,&xadj);


 69:   PetscMalloc1(xadj[ni],&adjncy);

 71:   for (PetscInt i=0; i<ni; i++) {
 73:   }

 75:   PetscFClose(PETSC_COMM_SELF,fp);

 77:   PetscSNPrintf(fname,sizeof(fname),"%s.%d.graph.xyz",prefix,rank);
 78:   PetscFOpen(PETSC_COMM_SELF,fname,"r",&fp);

 80:   PetscMalloc3(ni*ndims,&xyz,ni,&part,size,&tpwgts);
 81:   PetscMalloc1(ni*ndims,&sxyz);

 84:   for (PetscInt i=0; i<ni*ndims; i++) sxyz[i] = (size_t) xyz[i];

 86:   PetscFClose(PETSC_COMM_SELF,fp);

 88:   vwgt = NULL;

 90:   for (PetscInt i = 0; i < size; i++) tpwgts[i] = 1. / size;
 91:   isize = size;

 93:   ubvec[0]   = 1.05;
 94:   options[0] = 0;
 95:   options[1] = 2;
 96:   options[2] = 15;
 97:   options[3] = 0;
 98:   options[4] = 0;

100:   MPI_Comm_dup(MPI_COMM_WORLD, &comm);
101:   ParMETIS_V3_PartGeomKway(vtxdist, xadj, adjncy, vwgt, NULL, &wgtflag, &numflag, &ndims, sxyz, &ncon, &isize, tpwgts, ubvec,options, &edgecut, part, &comm);
102:   MPI_Comm_free(&comm);

104:   PetscFree(vtxdist);
105:   PetscFree(xadj);
106:   PetscFree(adjncy);
107:   PetscFree3(xyz,part,tpwgts);
108:   PetscFree(sxyz);
109:   PetscFinalize();
110:   return 0;
111: }

113: /*TEST

115:    build:
116:       requires: parmetis

118:    test:
119:       nsize: 2
120:       requires: parmetis datafilespath !complex double !defined(PETSC_USE_64BIT_INDICES)
121:       args: -prefix ${DATAFILESPATH}/parmetis-test/testnp2

123:    test:
124:       suffix: 2
125:       nsize: 4
126:       requires: parmetis datafilespath !complex double !defined(PETSC_USE_64BIT_INDICES)
127:       args: -prefix ${DATAFILESPATH}/parmetis-test/testnp4

129: TEST*/