Actual source code: ex152.c
petsc-3.5.4 2015-05-23
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: PetscMPIInt rank, size;
31: int i, status;
32: idx_t ni,isize,*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: #if defined(PETSC_USE_64BIT_INDICES)
42: PetscPrintf(PETSC_COMM_WORLD,"This example only works with 32 bit indices\n");
43: #endif
44: MPI_Comm_rank(PETSC_COMM_WORLD,&rank);
45: MPI_Comm_size(PETSC_COMM_WORLD,&size);
47: PetscOptionsBegin(PETSC_COMM_WORLD,NULL,"Parmetis test options","");
48: PetscOptionsString("-prefix","Path and prefix of test file","",prefix,prefix,sizeof(prefix),&flg);
49: if (!flg) SETERRQ(PETSC_COMM_WORLD,PETSC_ERR_USER,"Must specify -prefix");
50: PetscOptionsEnd();
52: PetscMalloc1((size+1),&vtxdist);
54: PetscSNPrintf(fname,sizeof(fname),"%s.%d.graph",prefix,rank);
56: PetscFOpen(PETSC_COMM_SELF,fname,"r",&fp);
58: fread(vtxdist, sizeof(idx_t), size+1, fp);
60: ni = vtxdist[rank+1]-vtxdist[rank];
62: PetscMalloc1((ni+1),&xadj);
64: fread(xadj, sizeof(idx_t), ni+1, fp);
66: PetscMalloc1(xadj[ni],&adjncy);
68: for (i=0; i<ni; i++) fread(&adjncy[xadj[i]], sizeof(idx_t), xadj[i+1]-xadj[i], fp);
70: PetscFClose(PETSC_COMM_SELF,fp);
72: PetscSNPrintf(fname,sizeof(fname),"%s.%d.graph.xyz",prefix,rank);
73: PetscFOpen(PETSC_COMM_SELF,fname,"r",&fp);
75: PetscMalloc3(ni*ndims,&xyz,ni,&part,size,&tpwgts);
77: fread(xyz, sizeof(real_t), ndims*ni, fp);
78: PetscFClose(PETSC_COMM_SELF,fp);
80: vwgt = NULL;
82: for (i = 0; i < size; i++) tpwgts[i] = 1. / size;
83: isize = size;
85: ubvec[0] = 1.05;
86: options[0] = 1;
87: options[1] = 2;
88: options[2] = 15;
89: options[3] = 0;
90: options[4] = 0;
92: MPI_Comm_dup(MPI_COMM_WORLD, &comm);
93: status = ParMETIS_V3_PartGeomKway(vtxdist, xadj, adjncy, vwgt,
94: NULL, &wgtflag, &numflag, &ndims, xyz, &ncon, &isize, tpwgts, ubvec,
95: options, &edgecut, part, &comm);CHKERRQPARMETIS(status);
96: MPI_Comm_free(&comm);
98: PetscFree(vtxdist);
99: PetscFree(xadj);
100: PetscFree(adjncy);
101: PetscFree3(xyz,part,tpwgts);
102: PetscFinalize();
103: return 0;
104: }