From 9ade92ba36d2529dab32b441a086f6c9164d90c7 Mon Sep 17 00:00:00 2001 From: James E McClure Date: Sat, 19 May 2018 07:49:32 -0400 Subject: [PATCH] the queen's croquet field --- tests/BlobAnalyzeParallel.cpp | 2 +- tests/ComponentLabel.cpp | 2 +- tests/GenerateSphereTest.cpp | 5 +-- tests/TestBlobAnalyze.cpp | 2 +- tests/TestBubble.cpp | 2 +- tests/TestBubbleDFH.cpp | 22 ++++-------- tests/TestColorGrad.cpp | 2 +- tests/TestColorGradDFH.cpp | 4 +-- tests/TestColorMassBounceback.cpp | 6 ++-- tests/TestColorSquareTube.cpp | 8 ++--- tests/TestCommD3Q19.cpp | 2 +- tests/TestFluxBC.cpp | 2 +- tests/TestForceMoments.cpp | 48 +++------------------------ tests/TestInterfaceSpeed.cpp | 7 ++-- tests/TestMRT.cpp | 2 +- tests/TestMap.cpp | 2 +- tests/TestPoiseuille.cpp | 19 ++--------- tests/TestPressVel.cpp | 16 ++------- tests/TestSegDist.cpp | 4 +-- tests/TestTorus.cpp | 4 +-- tests/TestTwoPhase.cpp | 2 +- tests/lbpm_BGK_simulator.cpp | 2 +- tests/lbpm_captube_pp.cpp | 2 +- tests/lbpm_color_macro_simulator.cpp | 2 +- tests/lbpm_color_simulator.cpp | 2 +- tests/lbpm_dfh_simulator.cpp | 2 +- tests/lbpm_inkbottle_pp.cpp | 2 +- tests/lbpm_morphdrain_pp.cpp | 4 +-- tests/lbpm_morphopen_pp.cpp | 4 +-- tests/lbpm_nondarcy_simulator.cpp | 2 +- tests/lbpm_nonnewtonian_simulator.cpp | 4 +-- tests/lbpm_permeability_simulator.cpp | 2 +- tests/lbpm_plates_pp.cpp | 2 +- tests/lbpm_porenetwork_pp.cpp | 4 +-- tests/lbpm_random_pp.cpp | 4 +-- tests/lbpm_refine_pp.cpp | 2 +- tests/lbpm_segmented_decomp.cpp | 2 +- tests/lbpm_segmented_pp.cpp | 2 +- tests/lbpm_squaretube_pp.cpp | 2 +- 39 files changed, 66 insertions(+), 143 deletions(-) diff --git a/tests/BlobAnalyzeParallel.cpp b/tests/BlobAnalyzeParallel.cpp index 3fa10352..c9e3f8fc 100644 --- a/tests/BlobAnalyzeParallel.cpp +++ b/tests/BlobAnalyzeParallel.cpp @@ -290,7 +290,7 @@ int main(int argc, char **argv) } } } - Dm.CommInit(comm); // Initialize communications for domains + Dm.CommInit(); // Initialize communications for domains MPI_Allreduce(&sum,&sum_global,1,MPI_DOUBLE,MPI_SUM,comm); porosity = sum_global/Dm.Volume; diff --git a/tests/ComponentLabel.cpp b/tests/ComponentLabel.cpp index 0a18ba0b..07ef6555 100644 --- a/tests/ComponentLabel.cpp +++ b/tests/ComponentLabel.cpp @@ -331,7 +331,7 @@ int main(int argc, char **argv) } porosity /= (Nx*Ny*Nz*1.0); printf("Media porosity is %f \n",porosity); - Dm.CommInit(comm); + Dm.CommInit(); /* **************************************************************** IDENTIFY ALL COMPONENTS FOR BOTH PHASES diff --git a/tests/GenerateSphereTest.cpp b/tests/GenerateSphereTest.cpp index 3293205c..48b4840f 100644 --- a/tests/GenerateSphereTest.cpp +++ b/tests/GenerateSphereTest.cpp @@ -420,9 +420,7 @@ int main(int argc, char **argv) } } } - Dm.CommInit(comm); - - int dist_mem_size = N*sizeof(double); + Dm.CommInit(); if (rank==0) printf("Number of nodes per side = %i \n", Nx); if (rank==0) printf("Total Number of nodes = %i \n", N); @@ -437,7 +435,6 @@ int main(int argc, char **argv) char LocalRankString[8]; char LocalRankFilename[40]; char LocalRestartFile[40]; - char tmpstr[10]; sprintf(LocalRankString,"%05d",rank); sprintf(LocalRankFilename,"%s%s","ID.",LocalRankString); sprintf(LocalRestartFile,"%s%s","Restart.",LocalRankString); diff --git a/tests/TestBlobAnalyze.cpp b/tests/TestBlobAnalyze.cpp index 3adbcafe..d2df9f86 100644 --- a/tests/TestBlobAnalyze.cpp +++ b/tests/TestBlobAnalyze.cpp @@ -234,7 +234,7 @@ int main(int argc, char **argv) } } //....................................................................... - Dm->CommInit(comm); // Initialize communications for domains + Dm->CommInit(); // Initialize communications for domains //....................................................................... // Read in sphere pack (initialize the non-wetting phase as inside of spheres) // diff --git a/tests/TestBubble.cpp b/tests/TestBubble.cpp index 84aaddcd..c03e5dea 100644 --- a/tests/TestBubble.cpp +++ b/tests/TestBubble.cpp @@ -157,7 +157,7 @@ int main(int argc, char **argv) // Full domain used for averaging (do not use mask for analysis) Domain Dm(Nx,Ny,Nz,rank,nprocx,nprocy,nprocz,Lx,Ly,Lz,pBC); - Dm.CommInit(comm); + Dm.CommInit(); // Mask that excludes the solid phase Domain Mask(Nx,Ny,Nz,rank,nprocx,nprocy,nprocz,Lx,Ly,Lz,pBC); diff --git a/tests/TestBubbleDFH.cpp b/tests/TestBubbleDFH.cpp index 39bd6b68..10a990c5 100644 --- a/tests/TestBubbleDFH.cpp +++ b/tests/TestBubbleDFH.cpp @@ -112,9 +112,6 @@ int main(int argc, char **argv) int Nx = size[0]; int Ny = size[1]; int Nz = size[2]; - double Lx = L[0]; - double Ly = L[1]; - double Lz = L[2]; int nprocx = nproc[0]; int nprocy = nproc[1]; int nprocz = nproc[2]; @@ -167,14 +164,14 @@ int main(int argc, char **argv) pBC=false; // Full domain used for averaging (do not use mask for analysis) - std::shared_ptr Dm(new Domain(domain_db)); + std::shared_ptr Dm(new Domain(domain_db,comm)); for (int i=0; iNx*Dm->Ny*Dm->Nz; i++) Dm->id[i] = 1; std::shared_ptr Averages( new TwoPhase(Dm) ); // TwoPhase Averages(Dm); - Dm->CommInit(comm); + Dm->CommInit(); // Mask that excludes the solid phase - std::shared_ptr Mask(new Domain(domain_db)); + std::shared_ptr Mask(new Domain(domain_db,comm)); MPI_Barrier(comm); Nx+=2; Ny+=2; Nz += 2; @@ -187,7 +184,6 @@ int main(int argc, char **argv) char LocalRankString[8]; char LocalRankFilename[40]; char LocalRestartFile[40]; - char tmpstr[10]; sprintf(LocalRankString,"%05d",rank); sprintf(LocalRankFilename,"%s%s","ID.",LocalRankString); sprintf(LocalRestartFile,"%s%s","Restart.",LocalRankString); @@ -198,9 +194,6 @@ int main(int argc, char **argv) char *id; id = new char[N]; double sum, sum_local; - double iVol_global = 1.0/(1.0*(Nx-2)*(Ny-2)*(Nz-2)*nprocs); - if (BoundaryCondition > 0) iVol_global = 1.0/(1.0*(Nx-2)*nprocx*(Ny-2)*nprocy*((Nz-2)*nprocz-6)); - double porosity, pore_vol; //........................................................................... if (rank == 0) cout << "Setting up bubble..." << endl; double BubbleRadius = 15.5; // Radius of the capillary tube @@ -250,7 +243,7 @@ int main(int argc, char **argv) // Initialize communication structures in averaging domain for (i=0; iNx*Mask->Ny*Mask->Nz; i++) Mask->id[i] = id[i]; - Mask->CommInit(comm); + Mask->CommInit(); double *PhaseLabel; PhaseLabel = new double[N]; @@ -407,7 +400,6 @@ int main(int argc, char **argv) //......................................... err = 1.0; - double sat_w_previous = 1.01; // slightly impossible value! if (rank==0) printf("Begin timesteps: error tolerance is %f \n", tol); //************ MAIN ITERATION LOOP ***************************************/ @@ -544,7 +536,7 @@ int main(int argc, char **argv) } } FILE *GFILE; - sprintf(LocalRankFilename,"Gradient.raw",rank); + sprintf(LocalRankFilename,"Gradient.raw"); GFILE = fopen(LocalRankFilename,"wb"); fwrite(GradNorm.data(),8,N,GFILE); fclose(GFILE); @@ -554,12 +546,12 @@ int main(int argc, char **argv) ScaLBL_Comm->RegularLayout(Map,&Den[0],Rho1); ScaLBL_Comm->RegularLayout(Map,&Den[Np],Rho2); FILE *RFILE1; - sprintf(LocalRankFilename,"Rho1.raw",rank); + sprintf(LocalRankFilename,"Rho1.raw"); RFILE1 = fopen(LocalRankFilename,"wb"); fwrite(Rho1.data(),8,N,RFILE1); fclose(RFILE1); FILE *RFILE2; - sprintf(LocalRankFilename,"Rho2.raw",rank); + sprintf(LocalRankFilename,"Rho2.raw"); RFILE2 = fopen(LocalRankFilename,"wb"); fwrite(Rho2.data(),8,N,RFILE2); fclose(RFILE2); diff --git a/tests/TestColorGrad.cpp b/tests/TestColorGrad.cpp index 9a00f897..5cd6d924 100644 --- a/tests/TestColorGrad.cpp +++ b/tests/TestColorGrad.cpp @@ -174,7 +174,7 @@ int main(int argc, char **argv) } } } - Dm.CommInit(comm); + Dm.CommInit(); MPI_Barrier(comm); if (rank == 0) cout << "Domain set." << endl; if (rank==0) printf ("Create ScaLBL_Communicator \n"); diff --git a/tests/TestColorGradDFH.cpp b/tests/TestColorGradDFH.cpp index 17837fb9..a4c8ce2c 100644 --- a/tests/TestColorGradDFH.cpp +++ b/tests/TestColorGradDFH.cpp @@ -88,7 +88,7 @@ int main(int argc, char **argv) } // Get the rank info - std::shared_ptr Dm(new Domain(db)); + std::shared_ptr Dm(new Domain(db,comm)); Nx += 2; Ny += 2; Nz += 2; @@ -108,7 +108,7 @@ int main(int argc, char **argv) } } } - Dm->CommInit(comm); + Dm->CommInit(); MPI_Barrier(comm); if (rank == 0) cout << "Domain set." << endl; if (rank==0) printf ("Create ScaLBL_Communicator \n"); diff --git a/tests/TestColorMassBounceback.cpp b/tests/TestColorMassBounceback.cpp index e8df5ae8..dc6a9525 100644 --- a/tests/TestColorMassBounceback.cpp +++ b/tests/TestColorMassBounceback.cpp @@ -118,9 +118,9 @@ int main(int argc, char **argv) pBC=false; // Full domain used for averaging (do not use mask for analysis) - std::shared_ptr Dm(new Domain(domain_db)); + std::shared_ptr Dm(new Domain(domain_db,comm)); for (int i=0; iNx*Dm->Ny*Dm->Nz; i++) Dm->id[i] = 1; - Dm->CommInit(comm); + Dm->CommInit(); MPI_Barrier(comm); Nx+=2; Ny+=2; Nz += 2; @@ -152,7 +152,7 @@ int main(int argc, char **argv) } } } - Dm->CommInit(comm); + Dm->CommInit(); MPI_Barrier(comm); if (rank == 0) cout << "Domain set." << endl; if (rank==0) printf ("Create ScaLBL_Communicator \n"); diff --git a/tests/TestColorSquareTube.cpp b/tests/TestColorSquareTube.cpp index dc63f9d6..3a763b22 100644 --- a/tests/TestColorSquareTube.cpp +++ b/tests/TestColorSquareTube.cpp @@ -115,8 +115,8 @@ int main(int argc, char **argv) double iVol_global = 1.0/Nx/Ny/Nz/nprocx/nprocy/nprocz; - std::shared_ptr Dm (new Domain(db)); - Dm->CommInit(comm); + std::shared_ptr Dm (new Domain(db,comm)); + Dm->CommInit(); Nx += 2; Ny += 2; @@ -164,7 +164,7 @@ int main(int argc, char **argv) } } } - Dm->CommInit(comm); + Dm->CommInit(); //....................................................................... // Compute the media porosity, assign phase labels and solid composition @@ -174,7 +174,7 @@ int main(int argc, char **argv) int Np=0; // number of local pore nodes double *PhaseLabel; PhaseLabel = new double[N]; - Dm->AssignComponentLabels(PhaseLabel); + //Dm->AssignComponentLabels(PhaseLabel); //....................................................................... for (k=1;kNx*Dm->Ny*Dm->Nz; i++) Dm->id[i] = id[i]; - Dm->CommInit(comm); + Dm->CommInit(); Np=0; // number of local pore nodes //....................................................................... diff --git a/tests/TestForceMoments.cpp b/tests/TestForceMoments.cpp index 94f4c101..1fb1e0a4 100644 --- a/tests/TestForceMoments.cpp +++ b/tests/TestForceMoments.cpp @@ -67,9 +67,7 @@ int main(int argc, char **argv) } // BGK Model parameters - unsigned int nBlocks, nthreads; - int timestepMax, interval; - double tau,Fx,Fy,Fz,tol; + double tau,Fx,Fy,Fz; // Domain variables int i,j,k,n; int dim = 3; if (rank == 0) printf("dim=%d\n",dim); @@ -77,7 +75,6 @@ int main(int argc, char **argv) int timesteps = 2; tau =1.0; - double mu=(tau-0.5)/3.0; double rlx_setA=1.0/tau; double rlx_setB = 8.f*(2.f-rlx_setA)/(8.f-rlx_setA); Fx = Fy = 1.0; @@ -115,9 +112,7 @@ int main(int argc, char **argv) printf("\n\n"); } - double iVol_global = 1.0/Nx/Ny/Nz/nprocx/nprocy/nprocz; - - std::shared_ptr Dm(new Domain(domain_db)); + std::shared_ptr Dm(new Domain(domain_db,comm)); Nx += 2; Ny += 2; @@ -147,7 +142,7 @@ int main(int argc, char **argv) } } } - Dm->CommInit(comm); + Dm->CommInit(); MPI_Barrier(comm); if (rank == 0) cout << "Domain set." << endl; @@ -264,43 +259,8 @@ int main(int argc, char **argv) MLUPS *= nprocs; if (rank==0) printf("Lattice update rate (process)= %f MLUPS \n", MLUPS); if (rank==0) printf("********************************************************\n"); - - // Number of memory references from the swap algorithm (per timestep) - // 18 reads and 18 writes for each lattice site - double MemoryRefs = Np*38; - - int SIZE=Np*sizeof(double); - /* - double *Vz; - Vz= new double [Np]; - double *Vx; - Vx= new double [Np]; - double *Vy; - Vy= new double [Np]; - ScaLBL_D3Q19_AA_Velocity(dist, &dist[10*Np],Velocity, Np); - ScaLBL_DeviceBarrier(); MPI_Barrier(comm); - ScaLBL_CopyToHost(&Vx[0],&Velocity[0],SIZE); - ScaLBL_CopyToHost(&Vy[0],&Velocity[Np],SIZE); - ScaLBL_CopyToHost(&Vz[0],&Velocity[2*Np],SIZE); - - printf("Force: %f,%f,%f \n",Fx,Fy,Fz); - double vz; - double W = 1.f*Nx-4; - j=Ny/2; k=Nz/2; - for (j=1;jid[n]); - n = Map(i,j,k); - //printf("%i,%i,%i; %i :",i,j,k,n); - if (n<0) vz =0.f; - else vz=Vz[n]; - printf("%f ",vz); - } - printf("\n"); - } - */ + int SIZE=Np*sizeof(double); double *DIST; DIST= new double [19*Np]; ScaLBL_CopyToHost(&DIST[0],&dist[0],19*SIZE); diff --git a/tests/TestInterfaceSpeed.cpp b/tests/TestInterfaceSpeed.cpp index 84942b85..aa7ca139 100644 --- a/tests/TestInterfaceSpeed.cpp +++ b/tests/TestInterfaceSpeed.cpp @@ -35,15 +35,12 @@ int main (int argc, char *argv[]) int Nx = domain_db->getVector( "n" )[0]; int Ny = domain_db->getVector( "n" )[1]; int Nz = domain_db->getVector( "n" )[2]; - int nprocx = domain_db->getVector( "nproc" )[0]; - int nprocy = domain_db->getVector( "nproc" )[1]; - int nprocz = domain_db->getVector( "nproc" )[2]; - std::shared_ptr Dm(new Domain(domain_db)); + std::shared_ptr Dm(new Domain(domain_db,comm)); for (i=0; iNx*Dm->Ny*Dm->Nz; i++) Dm->id[i] = 1; - Dm->CommInit(comm); + Dm->CommInit(); std::shared_ptr Averages(new TwoPhase(Dm)); int timestep=0; diff --git a/tests/TestMRT.cpp b/tests/TestMRT.cpp index 682735f4..30f46689 100644 --- a/tests/TestMRT.cpp +++ b/tests/TestMRT.cpp @@ -651,7 +651,7 @@ int main(int argc, char **argv) fclose(IDFILE); MPI_Barrier(comm); - Dm.CommInit(comm); + Dm.CommInit(); //....................................................................... // Compute the media porosity diff --git a/tests/TestMap.cpp b/tests/TestMap.cpp index 17541753..f7a013da 100644 --- a/tests/TestMap.cpp +++ b/tests/TestMap.cpp @@ -146,7 +146,7 @@ int main(int argc, char **argv) } } } - Dm->CommInit(comm); + Dm->CommInit(); // Create a communicator for the device (will use optimized layout) std::shared_ptr ScaLBL_Comm(new ScaLBL_Communicator(Dm)); diff --git a/tests/TestPoiseuille.cpp b/tests/TestPoiseuille.cpp index 580486c5..73909c93 100644 --- a/tests/TestPoiseuille.cpp +++ b/tests/TestPoiseuille.cpp @@ -30,8 +30,7 @@ int main(int argc, char **argv) } // BGK Model parameters - int timestepMax, interval; - double tau,Fx,Fy,Fz,tol; + double tau,Fx,Fy,Fz; // Domain variables int i,j,k,n; int timestep = 0; @@ -75,7 +74,7 @@ int main(int argc, char **argv) double iVol_global = 1.0/Nx/Ny/Nz/nprocx/nprocy/nprocz; - std::shared_ptr Dm( new Domain(domain_db)); + std::shared_ptr Dm( new Domain(domain_db,comm)); Nx += 2; Ny += 2; @@ -108,7 +107,7 @@ int main(int argc, char **argv) } } - Dm->CommInit(comm); + Dm->CommInit(); MPI_Barrier(comm); //....................................................................... @@ -226,18 +225,6 @@ int main(int argc, char **argv) // if (rank==0) printf("CPU time = %f \n", cputime); // if (rank==0) printf("Lattice update rate (per process)= %f MLUPS \n", MLUPS); MLUPS *= nprocs; - // if (rank==0) printf("Lattice update rate (process)= %f MLUPS \n", MLUPS); - // if (rank==0) printf("********************************************************\n"); - - // Number of memory references from the swap algorithm (per timestep) - // 18 reads and 18 writes for each lattice site - double MemoryRefs = Np*38; - // number of memory references for the swap algorithm - GigaBytes / second - // if (rank==0) printf("DRAM bandwidth (per process)= %f GB/sec \n",MemoryRefs*8*timestep/1e9/cputime); - // Report bandwidth in Gigabits per second - // communication bandwidth includes both send and recieve - //if (rank==0) printf("Communication bandwidth (per process)= %f Gbit/sec \n",ScaLBL_Comm->CommunicationCount*64*timestep/1e9/cputime); - // if (rank==0) printf("Aggregated communication bandwidth = %f Gbit/sec \n",nprocs*ScaLBL_Comm->CommunicationCount*64*timestep/1e9/cputime); double *Vz; Vz= new double [Np]; diff --git a/tests/TestPressVel.cpp b/tests/TestPressVel.cpp index 1bbdd3c6..e655ced9 100644 --- a/tests/TestPressVel.cpp +++ b/tests/TestPressVel.cpp @@ -30,18 +30,8 @@ int main(int argc, char **argv) printf("********************************************************\n"); } - // BGK Model parameters - unsigned int nBlocks, nthreads; - int timestepMax, interval; - double tau,Fx,Fy,Fz,tol; // Domain variables int i,j,k,n; - double rlx_setA=1.0; - double rlx_setB=1.0; - - Fx = Fy = 0.f; - Fz = 1.0e-4; - // Load inputs string FILENAME = argv[1]; // Load inputs @@ -76,8 +66,8 @@ int main(int argc, char **argv) double iVol_global = 1.0/Nx/Ny/Nz/nprocx/nprocy/nprocz; - std::shared_ptr Dm (new Domain(domain_db)); - Dm->CommInit(comm); + std::shared_ptr Dm (new Domain(domain_db,comm)); + Dm->CommInit(); Nx += 2; Ny += 2; @@ -92,7 +82,7 @@ int main(int argc, char **argv) char LocalRankFilename[40]; sprintf(LocalRankFilename,"ID.%05i",rank); - Dm->CommInit(comm); + Dm->CommInit(); //....................................................................... // Compute the media porosity diff --git a/tests/TestSegDist.cpp b/tests/TestSegDist.cpp index 5866101d..f431042a 100644 --- a/tests/TestSegDist.cpp +++ b/tests/TestSegDist.cpp @@ -55,7 +55,7 @@ int main(int argc, char **argv) // Get the rank info - Domain Dm(db); + Domain Dm(db,comm); for (int k=0;k Dm(new Domain(db)); + std::shared_ptr Dm(new Domain(db,comm)); // const RankInfoStruct rank_info(rank,nprocx,nprocy,nprocz); std::shared_ptr Averages(new TwoPhase(Dm)); Nx += 2; @@ -77,7 +77,7 @@ int main(int argc, char **argv) } } //....................................................................... - Dm->CommInit(comm); // Initialize communications for domains + Dm->CommInit(); // Initialize communications for domains //....................................................................... //....................................................................... diff --git a/tests/TestTwoPhase.cpp b/tests/TestTwoPhase.cpp index 3ee6d7ef..a979314a 100644 --- a/tests/TestTwoPhase.cpp +++ b/tests/TestTwoPhase.cpp @@ -49,7 +49,7 @@ int main(int argc, char **argv) for (i=0; i Dm (new Domain(Nx,Ny,Nz,rank,nprocx,nprocy,nprocz,Lx,Ly,Lz,BC)); - Dm->CommInit(comm); + Dm->CommInit(); std::shared_ptr Averages( new TwoPhase(Dm) ); InitializeRanks( rank, nprocx, nprocy, nprocz, iproc, jproc, kproc, diff --git a/tests/lbpm_color_macro_simulator.cpp b/tests/lbpm_color_macro_simulator.cpp index d99842ec..1c619c5a 100644 --- a/tests/lbpm_color_macro_simulator.cpp +++ b/tests/lbpm_color_macro_simulator.cpp @@ -258,7 +258,7 @@ int main(int argc, char **argv) for (i=0; i Averages( new TwoPhase(Dm) ); // TwoPhase Averages(Dm); - Dm.CommInit(comm); + Dm.CommInit(); // Mask that excludes the solid phase Domain Mask(Nx,Ny,Nz,rank,nprocx,nprocy,nprocz,Lx,Ly,Lz,BoundaryCondition); diff --git a/tests/lbpm_color_simulator.cpp b/tests/lbpm_color_simulator.cpp index 6268b74f..896391ef 100644 --- a/tests/lbpm_color_simulator.cpp +++ b/tests/lbpm_color_simulator.cpp @@ -326,7 +326,7 @@ int main(int argc, char **argv) Domain Dm(Nx,Ny,Nz,rank,nprocx,nprocy,nprocz,Lx,Ly,Lz,BoundaryCondition); for (i=0; i Averages( new TwoPhase(Dm) ); - Dm.CommInit(comm); + Dm.CommInit(); // Mask that excludes the solid phase Domain Mask(Nx,Ny,Nz,rank,nprocx,nprocy,nprocz,Lx,Ly,Lz,BoundaryCondition); diff --git a/tests/lbpm_dfh_simulator.cpp b/tests/lbpm_dfh_simulator.cpp index 3b7ff14c..5e1c08b2 100644 --- a/tests/lbpm_dfh_simulator.cpp +++ b/tests/lbpm_dfh_simulator.cpp @@ -148,7 +148,7 @@ int main(int argc, char **argv) std::shared_ptr Dm (new Domain(domain_db)); for (int i=0; iNx*Dm->Ny*Dm->Nz; i++) Dm->id[i] = 1; - Dm->CommInit(comm); + Dm->CommInit(); std::shared_ptr Averages( new TwoPhase(Dm) ); // Mask that excludes the solid phase diff --git a/tests/lbpm_inkbottle_pp.cpp b/tests/lbpm_inkbottle_pp.cpp index 012dac55..3c39219d 100644 --- a/tests/lbpm_inkbottle_pp.cpp +++ b/tests/lbpm_inkbottle_pp.cpp @@ -115,7 +115,7 @@ int main(int argc, char **argv) // Initialized domain and averaging framework for Two-Phase Flow std::shared_ptr Dm (new Domain(Nx,Ny,Nz,rank,nprocx,nprocy,nprocz,Lx,Ly,Lz,BC)); - Dm->CommInit(comm); + Dm->CommInit(); std::shared_ptr Averages( new TwoPhase(Dm) ); InitializeRanks( rank, nprocx, nprocy, nprocz, iproc, jproc, kproc, diff --git a/tests/lbpm_morphdrain_pp.cpp b/tests/lbpm_morphdrain_pp.cpp index 42250dcf..9b5cc7fa 100644 --- a/tests/lbpm_morphdrain_pp.cpp +++ b/tests/lbpm_morphdrain_pp.cpp @@ -148,7 +148,7 @@ int main(int argc, char **argv) } } */ - Dm.CommInit(comm); + Dm.CommInit(); int xdim,ydim,zdim; @@ -177,7 +177,7 @@ int main(int argc, char **argv) fclose(IDFILE); - Dm.CommInit(comm); + Dm.CommInit(); int iproc = Dm.iproc(); int jproc = Dm.jproc(); int kproc = Dm.kproc(); diff --git a/tests/lbpm_morphopen_pp.cpp b/tests/lbpm_morphopen_pp.cpp index 05793748..6f054d9f 100644 --- a/tests/lbpm_morphopen_pp.cpp +++ b/tests/lbpm_morphopen_pp.cpp @@ -131,7 +131,7 @@ int main(int argc, char **argv) } } } - Dm.CommInit(comm); + Dm.CommInit(); DoubleArray SignDist(nx,ny,nz); // Read the signed distance from file @@ -270,7 +270,7 @@ int main(int argc, char **argv) MPI_Barrier(comm); */ - Dm.CommInit(comm); + Dm.CommInit(); int iproc = Dm.iproc(); int jproc = Dm.jproc(); int kproc = Dm.kproc(); diff --git a/tests/lbpm_nondarcy_simulator.cpp b/tests/lbpm_nondarcy_simulator.cpp index 2e8da060..40672375 100644 --- a/tests/lbpm_nondarcy_simulator.cpp +++ b/tests/lbpm_nondarcy_simulator.cpp @@ -347,7 +347,7 @@ int main(int argc, char **argv) //......................................................... // Initialize communication structures in averaging domain for (i=0; i Averages( new TwoPhase(Dm) ); - Dm.CommInit(comm); /* 2 */ + Dm.CommInit(); /* 2 */ Domain Mask(Nx,Ny,Nz,rank,nprocx,nprocy,nprocz,Lx,Ly,Lz,BC); @@ -482,7 +482,7 @@ int main(int argc, char **argv) // Initialize communication structures in averaging domain // for (i=0; i Dm (new Domain(Nx,Ny,Nz,rank,nprocx,nprocy,nprocz,Lx,Ly,Lz,BC)); - Dm->CommInit(comm); + Dm->CommInit(); std::shared_ptr Averages( new TwoPhase(Dm) ); diff --git a/tests/lbpm_porenetwork_pp.cpp b/tests/lbpm_porenetwork_pp.cpp index 616a3a8d..496f9d86 100644 --- a/tests/lbpm_porenetwork_pp.cpp +++ b/tests/lbpm_porenetwork_pp.cpp @@ -101,11 +101,11 @@ int main(int argc, char **argv) // Initialized domain and averaging framework for Two-Phase Flow // Domain Dm(Nx,Ny,Nz,rank,nprocx,nprocy,nprocz,Lx,Ly,Lz,BC); - //Dm.CommInit(comm); + //Dm.CommInit(); //TwoPhase Averages(Dm); std::shared_ptr Dm (new Domain(Nx,Ny,Nz,rank,nprocx,nprocy,nprocz,Lx,Ly,Lz,BC)); - Dm->CommInit(comm); + Dm->CommInit(); std::shared_ptr Averages( new TwoPhase(Dm) ); MPI_Barrier(comm); diff --git a/tests/lbpm_random_pp.cpp b/tests/lbpm_random_pp.cpp index b6b75e0a..07c56e6f 100644 --- a/tests/lbpm_random_pp.cpp +++ b/tests/lbpm_random_pp.cpp @@ -141,7 +141,7 @@ int main(int argc, char **argv) } } } - Dm.CommInit(comm); + Dm.CommInit(); DoubleArray SignDist(nx,ny,nz); // Read the signed distance from file @@ -171,7 +171,7 @@ int main(int argc, char **argv) float porosity=float(totalGlobal)/(nprocx*nprocy*nprocz*(nx-2)*(ny-2)*(nz-2)); if (rank==0) printf("Media Porosity: %f \n",porosity); - Dm.CommInit(comm); + Dm.CommInit(); int iproc = Dm.iproc(); int jproc = Dm.jproc(); int kproc = Dm.kproc(); diff --git a/tests/lbpm_refine_pp.cpp b/tests/lbpm_refine_pp.cpp index 01c12464..08ca59ab 100644 --- a/tests/lbpm_refine_pp.cpp +++ b/tests/lbpm_refine_pp.cpp @@ -102,7 +102,7 @@ int main(int argc, char **argv) } } } - Dm.CommInit(comm); + Dm.CommInit(); DoubleArray SignDist(nx,ny,nz); // Read the signed distance from file diff --git a/tests/lbpm_segmented_decomp.cpp b/tests/lbpm_segmented_decomp.cpp index 75808ee5..3384e454 100644 --- a/tests/lbpm_segmented_decomp.cpp +++ b/tests/lbpm_segmented_decomp.cpp @@ -142,7 +142,7 @@ int main(int argc, char **argv) } } } - Dm.CommInit(comm); + Dm.CommInit(); // number of sites to use for periodic boundary condition transition zone int z_transition_size = (nprocz*nz - (Nz - zStart))/2; diff --git a/tests/lbpm_segmented_pp.cpp b/tests/lbpm_segmented_pp.cpp index d7cbd15f..aea481b4 100644 --- a/tests/lbpm_segmented_pp.cpp +++ b/tests/lbpm_segmented_pp.cpp @@ -189,7 +189,7 @@ int main(int argc, char **argv) std::shared_ptr Dm (new Domain(nx,ny,nz,rank,nprocx,nprocy,nprocz,Lx,Ly,Lz,BC)); for (n=0; nid[n]=1; - Dm->CommInit(comm); + Dm->CommInit(); std::shared_ptr Averages( new TwoPhase(Dm) ); nx+=2; ny+=2; nz+=2; diff --git a/tests/lbpm_squaretube_pp.cpp b/tests/lbpm_squaretube_pp.cpp index 691ada62..42715773 100644 --- a/tests/lbpm_squaretube_pp.cpp +++ b/tests/lbpm_squaretube_pp.cpp @@ -117,7 +117,7 @@ int main(int argc, char **argv) // Initialized domain and averaging framework for Two-Phase Flow std::shared_ptr Dm(new Domain(Nx,Ny,Nz,rank,nprocx,nprocy,nprocz,Lx,Ly,Lz,BC)); - Dm->CommInit(comm); + Dm->CommInit(); std::shared_ptr Averages(new TwoPhase(Dm)); InitializeRanks( rank, nprocx, nprocy, nprocz, iproc, jproc, kproc,