Actual source code: ex152.c
petsc-3.4.2 2013-07-02
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: * following two patches.
8: *
9: * http://petsc.cs.iit.edu/petsc/externalpackages/parmetis-4.0.2/rev/2dd2eae596ac
10: * http://petsc.cs.iit.edu/petsc/externalpackages/parmetis-4.0.2/rev/1c2b9fe39201
11: *
12: * The bug was reported upstream, but has received no action so far.
13: *
14: * http://glaros.dtc.umn.edu/gkhome/node/837
15: *
16: */
18: #include <petscsys.h>
19: #include <parmetis.h>
21: #define CHKERRQPARMETIS(n) \
22: if (n == METIS_ERROR_INPUT) SETERRQ(PETSC_COMM_SELF,PETSC_ERR_LIB,"ParMETIS error due to wrong inputs and/or options"); \
23: else if (n == METIS_ERROR_MEMORY) SETERRQ(PETSC_COMM_SELF,PETSC_ERR_LIB,"ParMETIS error due to insufficient memory"); \
24: else if (n == METIS_ERROR) SETERRQ(PETSC_COMM_SELF,PETSC_ERR_LIB,"ParMETIS general error"); \
26: int main(int argc, char *argv[])
27: {
29: PetscBool flg;
30: int rank, size;
31: int i, ni, status;
32: idx_t *vtxdist, *xadj, *adjncy, *vwgt, *part;
33: idx_t wgtflag=0, numflag=0, ncon=1, ndims=3, edgecut=0;
34: idx_t options[5];
35: real_t *xyz, *tpwgts, ubvec[1];
36: MPI_Comm comm;
37: FILE *fp;
38: char fname[PETSC_MAX_PATH_LEN],prefix[PETSC_MAX_PATH_LEN] = "";
40: PetscInitialize(&argc,&argv,NULL,help);
41: MPI_Comm_rank(PETSC_COMM_WORLD,&rank);
42: MPI_Comm_size(PETSC_COMM_WORLD,&size);
44: PetscOptionsBegin(PETSC_COMM_WORLD,NULL,"Parmetis test options","");
45: PetscOptionsString("-prefix","Path and prefix of test file","",prefix,prefix,sizeof(prefix),&flg);
46: if (!flg) SETERRQ(PETSC_COMM_WORLD,PETSC_ERR_USER,"Must specify -prefix");
47: PetscOptionsEnd();
49: PetscMalloc((size+1)*sizeof(idx_t),&vtxdist);
51: PetscSNPrintf(fname,sizeof(fname),"%s.%d.graph",prefix,rank);
53: PetscFOpen(PETSC_COMM_SELF,fname,"r",&fp);
55: fread(vtxdist, sizeof(idx_t), size+1, fp);
57: ni = vtxdist[rank+1]-vtxdist[rank];
59: PetscMalloc((ni+1)*sizeof(idx_t),&xadj);
61: fread(xadj, sizeof(idx_t), ni+1, fp);
63: PetscMalloc(xadj[ni]*sizeof(idx_t),&adjncy);
65: for (i=0; i<ni; i++) fread(&adjncy[xadj[i]], sizeof(idx_t), xadj[i+1]-xadj[i], fp);
67: PetscFClose(PETSC_COMM_SELF,fp);
69: PetscSNPrintf(fname,sizeof(fname),"%s.%d.graph.xyz",prefix,rank);
70: PetscFOpen(PETSC_COMM_SELF,fname,"r",&fp);
72: PetscMalloc3(ni*ndims,real_t,&xyz,ni,idx_t,&part,size,real_t,&tpwgts);
74: fread(xyz, sizeof(real_t), ndims*ni, fp);
75: PetscFClose(PETSC_COMM_SELF,fp);
77: vwgt = NULL;
79: for (i = 0; i < size; i++) tpwgts[i] = 1. / size;
81: ubvec[0] = 1.05;
82: options[0] = 1;
83: options[1] = 2;
84: options[2] = 15;
85: options[3] = 0;
86: options[4] = 0;
88: MPI_Comm_dup(MPI_COMM_WORLD, &comm);
89: status = ParMETIS_V3_PartGeomKway(vtxdist, xadj, adjncy, vwgt,
90: NULL, &wgtflag, &numflag, &ndims, xyz, &ncon, &size, tpwgts, ubvec,
91: options, &edgecut, part, &comm);CHKERRQPARMETIS(status);
92: MPI_Comm_free(&comm);
94: PetscFree(vtxdist);
95: PetscFree(xadj);
96: PetscFree(adjncy);
97: PetscFree3(xyz,part,tpwgts);
98: PetscFinalize();
99: return 0;
100: }