mirror of
https://github.com/paboyle/Grid.git
synced 2025-06-15 06:17:05 +01:00
Reorg of build structure
This commit is contained in:
476
tests/Grid_main.cc
Normal file
476
tests/Grid_main.cc
Normal file
@ -0,0 +1,476 @@
|
||||
#include "Grid.h"
|
||||
|
||||
using namespace std;
|
||||
using namespace Grid;
|
||||
using namespace Grid::QCD;
|
||||
|
||||
|
||||
int main (int argc, char ** argv)
|
||||
{
|
||||
Grid_init(&argc,&argv);
|
||||
|
||||
std::vector<int> latt_size(4);
|
||||
|
||||
std::vector<int> simd_layout(4);
|
||||
|
||||
std::vector<int> mpi_layout(4);
|
||||
mpi_layout[0]=1;
|
||||
mpi_layout[1]=1;
|
||||
mpi_layout[2]=1;
|
||||
mpi_layout[3]=1;
|
||||
|
||||
#ifdef AVX512
|
||||
for(int omp=128;omp<236;omp+=16){
|
||||
#else
|
||||
for(int omp=1;omp<8;omp*=20){
|
||||
#endif
|
||||
|
||||
#ifdef OMP
|
||||
omp_set_num_threads(omp);
|
||||
#endif
|
||||
|
||||
for(int lat=8;lat<=16;lat+=40){
|
||||
latt_size[0] = lat;
|
||||
latt_size[1] = lat;
|
||||
latt_size[2] = lat;
|
||||
latt_size[3] = lat;
|
||||
double volume = latt_size[0]*latt_size[1]*latt_size[2]*latt_size[3];
|
||||
|
||||
#ifdef AVX512
|
||||
simd_layout[0] = 1;
|
||||
simd_layout[1] = 2;
|
||||
simd_layout[2] = 2;
|
||||
simd_layout[3] = 2;
|
||||
#endif
|
||||
#if defined (AVX1)|| defined (AVX2)
|
||||
simd_layout[0] = 1;
|
||||
simd_layout[1] = 1;
|
||||
simd_layout[2] = 2;
|
||||
simd_layout[3] = 2;
|
||||
#endif
|
||||
#if defined (SSE4)
|
||||
simd_layout[0] = 1;
|
||||
simd_layout[1] = 1;
|
||||
simd_layout[2] = 1;
|
||||
simd_layout[3] = 2;
|
||||
#endif
|
||||
|
||||
GridCartesian Fine(latt_size,simd_layout,mpi_layout);
|
||||
GridRedBlackCartesian rbFine(latt_size,simd_layout,mpi_layout);
|
||||
|
||||
LatticeColourMatrix Foo(&Fine);
|
||||
LatticeColourMatrix Bar(&Fine);
|
||||
|
||||
LatticeSpinColourMatrix scFoo(&Fine);
|
||||
LatticeSpinColourMatrix scBar(&Fine);
|
||||
|
||||
LatticeColourMatrix Shifted(&Fine);
|
||||
LatticeColourMatrix ShiftedCheck(&Fine);
|
||||
LatticeColourMatrix rShifted(&rbFine);
|
||||
LatticeColourMatrix bShifted(&rbFine);
|
||||
|
||||
LatticeColourMatrix rFoo(&rbFine);
|
||||
LatticeColourMatrix bFoo(&rbFine);
|
||||
|
||||
LatticeColourMatrix FooBar(&Fine);
|
||||
LatticeSpinColourMatrix scFooBar(&Fine);
|
||||
|
||||
LatticeColourVector cVec(&Fine);
|
||||
LatticeSpinVector sVec(&Fine);
|
||||
LatticeSpinColourVector scVec(&Fine);
|
||||
|
||||
LatticeColourMatrix cMat(&Fine);
|
||||
LatticeSpinMatrix sMat(&Fine);
|
||||
LatticeSpinColourMatrix scMat(&Fine);
|
||||
|
||||
LatticeComplex scalar(&Fine);
|
||||
LatticeReal rscalar(&Fine);
|
||||
LatticeReal iscalar(&Fine);
|
||||
|
||||
SpinMatrix GammaFive;
|
||||
iSpinMatrix<vComplex> iGammaFive;
|
||||
ColourMatrix cmat;
|
||||
|
||||
random(Foo);
|
||||
gaussian(Bar);
|
||||
random(scFoo);
|
||||
random(scBar);
|
||||
|
||||
random(cMat);
|
||||
random(sMat);
|
||||
random(scMat);
|
||||
random(cVec);
|
||||
random(sVec);
|
||||
random(scVec);
|
||||
|
||||
fflush(stdout);
|
||||
cVec = cMat * cVec; // LatticeColourVector = LatticeColourMatrix * LatticeColourVector
|
||||
sVec = sMat * sVec; // LatticeSpinVector = LatticeSpinMatrix * LatticeSpinVector
|
||||
scVec= scMat * scVec;// LatticeSpinColourVector = LatticeSpinColourMatrix * LatticeSpinColourVector
|
||||
scVec= cMat * scVec; // LatticeSpinColourVector = LatticeColourMatrix * LatticeSpinColourVector
|
||||
scVec= sMat * scVec; // LatticeSpinColourVector = LatticeSpinMatrix * LatticeSpinColourVector
|
||||
|
||||
cMat = outerProduct(cVec,cVec);
|
||||
scalar = localInnerProduct(cVec,cVec);
|
||||
|
||||
scalar += scalar;
|
||||
scalar -= scalar;
|
||||
scalar *= scalar;
|
||||
add(scalar,scalar,scalar);
|
||||
sub(scalar,scalar,scalar);
|
||||
mult(scalar,scalar,scalar);
|
||||
mac(scalar,scalar,scalar);
|
||||
scalar = scalar+scalar;
|
||||
scalar = scalar-scalar;
|
||||
scalar = scalar*scalar;
|
||||
|
||||
scalar=outerProduct(scalar,scalar);
|
||||
|
||||
scalar=adj(scalar);
|
||||
|
||||
// rscalar=real(scalar);
|
||||
// iscalar=imag(scalar);
|
||||
// scalar =cmplx(rscalar,iscalar);
|
||||
|
||||
scalar=transpose(scalar);
|
||||
scalar=transposeIndex<1>(scalar);
|
||||
scalar=traceIndex<1>(scalar);
|
||||
scalar=peekIndex<1>(cVec,0);
|
||||
scalar=trace(scalar);
|
||||
scalar=localInnerProduct(cVec,cVec);
|
||||
scalar=localNorm2(cVec);
|
||||
|
||||
// -=,+=,*=,()
|
||||
// add,+,sub,-,mult,mac,*
|
||||
// adj,conj
|
||||
// real,imag
|
||||
// transpose,transposeIndex
|
||||
// trace,traceIndex
|
||||
// peekIndex
|
||||
// innerProduct,outerProduct,
|
||||
// localNorm2
|
||||
// localInnerProduct
|
||||
|
||||
scMat = sMat*scMat; // LatticeSpinColourMatrix = LatticeSpinMatrix * LatticeSpinColourMatrix
|
||||
|
||||
// Non-lattice (const objects) * Lattice
|
||||
ColourMatrix cm;
|
||||
SpinColourMatrix scm;
|
||||
vSpinColourMatrix vscm;
|
||||
Complex cplx(1.0);
|
||||
Integer myint=1;
|
||||
double mydouble=1.0;
|
||||
|
||||
// vSpinColourMatrix vscm;
|
||||
scMat = cMat*scMat;
|
||||
scm = cm * scm; // SpinColourMatrix = ColourMatrix * SpinColourMatrix
|
||||
scm = scm *cm; // SpinColourMatrix = SpinColourMartix * ColourMatrix
|
||||
scm = GammaFive * scm ; // SpinColourMatrix = SpinMatrix * SpinColourMatrix
|
||||
scm = scm* GammaFive ; // SpinColourMatrix = SpinColourMatrix * SpinMatrix
|
||||
|
||||
scm = scm*cplx;
|
||||
vscm = vscm*cplx;
|
||||
scMat = scMat*cplx;
|
||||
|
||||
scm = cplx*scm;
|
||||
vscm = cplx*vscm;
|
||||
scMat = cplx*scMat;
|
||||
scm = myint*scm;
|
||||
vscm = myint*vscm;
|
||||
scMat = scMat*myint;
|
||||
|
||||
scm = scm*mydouble;
|
||||
vscm = vscm*mydouble;
|
||||
scMat = scMat*mydouble;
|
||||
scMat = mydouble*scMat;
|
||||
cMat = mydouble*cMat;
|
||||
|
||||
sMat = adj(sMat); // LatticeSpinMatrix adjoint
|
||||
sMat = iGammaFive*sMat; // SpinMatrix * LatticeSpinMatrix
|
||||
sMat = GammaFive*sMat; // SpinMatrix * LatticeSpinMatrix
|
||||
scMat= adj(scMat);
|
||||
cMat= adj(cMat);
|
||||
cm=adj(cm);
|
||||
scm=adj(scm);
|
||||
scm=transpose(scm);
|
||||
scm=transposeIndex<1>(scm);
|
||||
|
||||
// Foo = Foo+scalar; // LatticeColourMatrix+Scalar
|
||||
// Foo = Foo*scalar; // LatticeColourMatrix*Scalar
|
||||
// Foo = Foo-scalar; // LatticeColourMatrix-Scalar
|
||||
// Foo = scalar*Foo; // Scalar*LatticeColourMatrix
|
||||
// Foo = scalar+Foo; // Scalar+LatticeColourMatrix
|
||||
// Foo = scalar-Foo; // Scalar-LatticeColourMatrix
|
||||
|
||||
LatticeComplex trscMat(&Fine);
|
||||
trscMat = trace(scMat); // Trace
|
||||
|
||||
{
|
||||
TComplex c;
|
||||
ColourMatrix c_m;
|
||||
SpinMatrix s_m;
|
||||
SpinColourMatrix sc_m;
|
||||
|
||||
s_m = traceIndex<1>(sc_m); // Map to traceColour
|
||||
c_m = traceIndex<2>(sc_m); // map to traceSpin
|
||||
|
||||
c = traceIndex<2>(s_m);
|
||||
c = traceIndex<1>(c_m);
|
||||
|
||||
s_m = peekIndex<1>(scm,0,0);
|
||||
c_m = peekIndex<2>(scm,1,2);
|
||||
|
||||
printf("c. Level %d\n",c_m.TensorLevel);
|
||||
printf("c. Level %d\n",c_m().TensorLevel);
|
||||
printf("c. Level %d\n",c_m()().TensorLevel);
|
||||
|
||||
c_m()() = scm()(0,0); //ColourComponents of CM <= ColourComponents of SpinColourMatrix
|
||||
scm()(1,1) = cm()(); //ColourComponents of CM <= ColourComponents of SpinColourMatrix
|
||||
}
|
||||
|
||||
FooBar = Bar;
|
||||
|
||||
/*
|
||||
{
|
||||
std::vector<int> coor(4);
|
||||
for(int d=0;d<4;d++) coor[d] = 0;
|
||||
peekSite(cmat,Foo,coor);
|
||||
Foo = zero;
|
||||
pokeSite(cmat,Foo,coor);
|
||||
}
|
||||
random(Foo);
|
||||
*/
|
||||
lex_sites(Foo);
|
||||
|
||||
Integer mm[4];
|
||||
mm[0]=1;
|
||||
mm[1]=Fine._rdimensions[0];
|
||||
mm[2]=Fine._ldimensions[0]*Fine._ldimensions[1];
|
||||
mm[3]=Fine._ldimensions[0]*Fine._ldimensions[1]*Fine._ldimensions[2];
|
||||
|
||||
LatticeInteger lex(&Fine);
|
||||
lex=zero;
|
||||
for(int d=0;d<4;d++){
|
||||
LatticeInteger coor(&Fine);
|
||||
LatticeCoordinate(coor,d);
|
||||
lex = lex + coor*mm[d];
|
||||
}
|
||||
|
||||
Bar = zero;
|
||||
Bar = where(lex<10,Foo,Bar);
|
||||
{
|
||||
std::vector<int> coor(4);
|
||||
for(coor[3]=0;coor[3]<latt_size[3]/mpi_layout[3];coor[3]++){
|
||||
for(coor[2]=0;coor[2]<latt_size[2]/mpi_layout[2];coor[2]++){
|
||||
for(coor[1]=0;coor[1]<latt_size[1]/mpi_layout[1];coor[1]++){
|
||||
for(coor[0]=0;coor[0]<latt_size[0]/mpi_layout[0];coor[0]++){
|
||||
ColourMatrix bar;
|
||||
peekSite(bar,Bar,coor);
|
||||
for(int r=0;r<3;r++){
|
||||
for(int c=0;c<3;c++){
|
||||
// cout<<"bar "<<coor[0]<<coor[1]<<coor[2]<<coor[3] <<" "<<bar._internal._internal[r][c]<<std::endl;
|
||||
}}
|
||||
}}}}
|
||||
}
|
||||
|
||||
//setCheckerboard(ShiftedCheck,rFoo);
|
||||
//setCheckerboard(ShiftedCheck,bFoo);
|
||||
|
||||
|
||||
// Lattice SU(3) x SU(3)
|
||||
Fine.Barrier();
|
||||
FooBar = Foo * Bar;
|
||||
|
||||
// Lattice 12x12 GEMM
|
||||
scFooBar = scFoo * scBar;
|
||||
|
||||
// Benchmark some simple operations LatticeSU3 * Lattice SU3.
|
||||
double t0,t1,flops;
|
||||
double bytes;
|
||||
int ncall=100;
|
||||
int Nc = Grid::QCD::Nc;
|
||||
|
||||
LatticeGaugeField U(&Fine);
|
||||
// LatticeColourMatrix Uy = U(yDir);
|
||||
|
||||
flops = ncall*1.0*volume*(8*Nc*Nc*Nc);
|
||||
bytes = ncall*1.0*volume*Nc*Nc *2*3*sizeof(Grid::Real);
|
||||
if ( Fine.IsBoss() ) {
|
||||
printf("%f flop and %f bytes\n",flops,bytes/ncall);
|
||||
}
|
||||
FooBar = Foo * Bar;
|
||||
Fine.Barrier();
|
||||
t0=usecond();
|
||||
for(int i=0;i<ncall;i++){
|
||||
Fine.Barrier();
|
||||
mult(FooBar,Foo,Bar); // this is better
|
||||
}
|
||||
t1=usecond();
|
||||
Fine.Barrier();
|
||||
if ( Fine.IsBoss() ) {
|
||||
#ifdef OMP
|
||||
printf("mult NumThread %d , Lattice size %d , %f us per call\n",omp_get_max_threads(),lat,(t1-t0)/ncall);
|
||||
#endif
|
||||
printf("mult NumThread %d , Lattice size %d , %f Mflop/s\n",omp,lat,flops/(t1-t0));
|
||||
printf("mult NumThread %d , Lattice size %d , %f MB/s\n",omp,lat,bytes/(t1-t0));
|
||||
}
|
||||
mult(FooBar,Foo,Bar);
|
||||
FooBar = Foo * Bar;
|
||||
|
||||
bytes = ncall*1.0*volume*Nc*Nc *2*5*sizeof(Grid::Real);
|
||||
Fine.Barrier();
|
||||
t0=usecond();
|
||||
for(int i=0;i<ncall;i++){
|
||||
Fine.Barrier();
|
||||
mult(FooBar,Foo,Cshift(Bar,1,-1));
|
||||
//mult(FooBar,Foo,Bar);
|
||||
//FooBar = Foo * Bar; // this is bad
|
||||
}
|
||||
t1=usecond();
|
||||
Fine.Barrier();
|
||||
|
||||
FooBar = Foo * Bar;
|
||||
|
||||
if ( Fine.IsBoss() ) {
|
||||
printf("Cshift Mult: NumThread %d , Lattice size %d , %f us per call\n",omp,lat,(t1-t0)/ncall);
|
||||
printf("Cshift Mult: NumThread %d , Lattice size %d , %f Mflop/s\n",omp,lat,flops/(t1-t0));
|
||||
printf("Cshift Mult: NumThread %d , Lattice size %d , %f MB/s\n",omp,lat,bytes/(t1-t0));
|
||||
}
|
||||
// pickCheckerboard(0,rFoo,FooBar);
|
||||
// pickCheckerboard(1,bFoo,FooBar);
|
||||
// setCheckerboard(FooBar,rFoo);
|
||||
// setCheckerboard(FooBar,bFoo);
|
||||
|
||||
double nrm=0;
|
||||
|
||||
|
||||
LatticeColourMatrix deriv(&Fine);
|
||||
double half=0.5;
|
||||
deriv = 0.5*Cshift(Foo,0,1) - 0.5*Cshift(Foo,0,-1);
|
||||
|
||||
|
||||
for(int dir=0;dir<4;dir++){
|
||||
for(int shift=0;shift<latt_size[dir];shift++){
|
||||
|
||||
pickCheckerboard(0,rFoo,Foo); // Pick out red or black checkerboards
|
||||
pickCheckerboard(1,bFoo,Foo);
|
||||
|
||||
if ( Fine.IsBoss() ) {
|
||||
std::cout << "Shifting both parities by "<< shift <<" direction "<< dir <<std::endl;
|
||||
}
|
||||
Shifted = Cshift(Foo,dir,shift); // Shift everything
|
||||
|
||||
bShifted = Cshift(rFoo,dir,shift); // Shift red->black
|
||||
rShifted = Cshift(bFoo,dir,shift); // Shift black->red
|
||||
|
||||
ShiftedCheck=zero;
|
||||
setCheckerboard(ShiftedCheck,bShifted); // Put them all together
|
||||
setCheckerboard(ShiftedCheck,rShifted); // and check the results (later)
|
||||
|
||||
// Check results
|
||||
std::vector<int> coor(4);
|
||||
for(coor[3]=0;coor[3]<latt_size[3]/mpi_layout[3];coor[3]++){
|
||||
for(coor[2]=0;coor[2]<latt_size[2]/mpi_layout[2];coor[2]++){
|
||||
for(coor[1]=0;coor[1]<latt_size[1]/mpi_layout[1];coor[1]++){
|
||||
for(coor[0]=0;coor[0]<latt_size[0]/mpi_layout[0];coor[0]++){
|
||||
|
||||
|
||||
|
||||
std::complex<Grid::Real> diff;
|
||||
|
||||
std::vector<int> shiftcoor = coor;
|
||||
shiftcoor[dir]=(shiftcoor[dir]+shift+latt_size[dir])%(latt_size[dir]/mpi_layout[dir]);
|
||||
|
||||
std::vector<int> rl(4);
|
||||
for(int dd=0;dd<4;dd++){
|
||||
rl[dd] = latt_size[dd]/simd_layout[dd]/mpi_layout[dd];
|
||||
}
|
||||
int lex = coor[0]%rl[0]
|
||||
+ (coor[1]%rl[1])*rl[0]
|
||||
+ (coor[2]%rl[2])*rl[0]*rl[1]
|
||||
+ (coor[3]%rl[3])*rl[0]*rl[1]*rl[2];
|
||||
lex +=
|
||||
+1000*(coor[0]/rl[0])
|
||||
+1000*(coor[1]/rl[1])*simd_layout[0]
|
||||
+1000*(coor[2]/rl[2])*simd_layout[0]*simd_layout[1]
|
||||
+1000*(coor[3]/rl[3])*simd_layout[0]*simd_layout[1]*simd_layout[2];
|
||||
|
||||
int lex_coor = shiftcoor[0]%rl[0]
|
||||
+ (shiftcoor[1]%rl[1])*rl[0]
|
||||
+ (shiftcoor[2]%rl[2])*rl[0]*rl[1]
|
||||
+ (shiftcoor[3]%rl[3])*rl[0]*rl[1]*rl[2];
|
||||
lex_coor +=
|
||||
+1000*(shiftcoor[0]/rl[0])
|
||||
+1000*(shiftcoor[1]/rl[1])*simd_layout[0]
|
||||
+1000*(shiftcoor[2]/rl[2])*simd_layout[0]*simd_layout[1]
|
||||
+1000*(shiftcoor[3]/rl[3])*simd_layout[0]*simd_layout[1]*simd_layout[2];
|
||||
|
||||
ColourMatrix foo;
|
||||
ColourMatrix bar;
|
||||
ColourMatrix shifted1;
|
||||
ColourMatrix shifted2;
|
||||
ColourMatrix shifted3;
|
||||
ColourMatrix foobar1;
|
||||
ColourMatrix foobar2;
|
||||
ColourMatrix mdiff,amdiff;
|
||||
|
||||
peekSite(shifted1,Shifted,coor);
|
||||
peekSite(shifted2,Foo,shiftcoor);
|
||||
peekSite(shifted3,ShiftedCheck,coor);
|
||||
peekSite(foo,Foo,coor);
|
||||
|
||||
mdiff = shifted1-shifted2;
|
||||
amdiff=adj(mdiff);
|
||||
ColourMatrix prod = amdiff*mdiff;
|
||||
Real Ttr=real(trace(prod));
|
||||
double nn=Ttr;
|
||||
if ( nn > 0 )
|
||||
cout<<"Shift real trace fail "<<coor[0]<<coor[1]<<coor[2]<<coor[3] <<endl;
|
||||
|
||||
|
||||
for(int r=0;r<3;r++){
|
||||
for(int c=0;c<3;c++){
|
||||
diff =shifted1()()(r,c)-shifted2()()(r,c);
|
||||
nn=real(conj(diff)*diff);
|
||||
if ( nn > 0 )
|
||||
cout<<"Shift fail (shifted1/shifted2-ref) "<<coor[0]<<coor[1]<<coor[2]<<coor[3] <<" "
|
||||
<<shifted1()()(r,c)<<" "<<shifted2()()(r,c)
|
||||
<< " "<< foo()()(r,c)<< " lex expect " << lex_coor << " lex "<<lex<<endl;
|
||||
else if(0)
|
||||
cout<<"Shift pass 1vs2 "<<coor[0]<<coor[1]<<coor[2]<<coor[3] <<" "
|
||||
<<shifted1()()(r,c)<<" "<<shifted2()()(r,c)
|
||||
<< " "<< foo()()(r,c)<< " lex expect " << lex_coor << " lex "<<lex<<endl;
|
||||
}}
|
||||
|
||||
for(int r=0;r<3;r++){
|
||||
for(int c=0;c<3;c++){
|
||||
diff =shifted3()()(r,c)-shifted2()()(r,c);
|
||||
nn=real(conj(diff)*diff);
|
||||
if ( nn > 0 )
|
||||
cout<<"Shift rb fail (shifted3/shifted2-ref) "<<coor[0]<<coor[1]<<coor[2]<<coor[3] <<" "
|
||||
<<shifted3()()(r,c)<<" "<<shifted2()()(r,c)
|
||||
<< " "<< foo()()(r,c)<< " lex expect " << lex_coor << " lex "<<lex<<endl;
|
||||
else if(0)
|
||||
cout<<"Shift rb pass 3vs2 "<<coor[0]<<coor[1]<<coor[2]<<coor[3] <<" "
|
||||
<<shifted3()()(r,c)<<" "<<shifted2()()(r,c)
|
||||
<< " "<< foo()()(r,c)<< " lex expect " << lex_coor << " lex "<<lex<<endl;
|
||||
}}
|
||||
peekSite(bar,Bar,coor);
|
||||
|
||||
peekSite(foobar1,FooBar,coor);
|
||||
foobar2 = foo*bar;
|
||||
for(int r=0;r<Nc;r++){
|
||||
for(int c=0;c<Nc;c++){
|
||||
diff =foobar2()()(r,c)-foobar1()()(r,c);
|
||||
nrm = nrm + real(conj(diff)*diff);
|
||||
}}
|
||||
}}}}
|
||||
if( Fine.IsBoss() ){
|
||||
std::cout << "LatticeColorMatrix * LatticeColorMatrix nrm diff = "<<nrm<<std::endl;
|
||||
}
|
||||
}}
|
||||
|
||||
} // loop for lat
|
||||
} // loop for omp
|
||||
Grid_finalize();
|
||||
}
|
15
tests/Makefile.am
Normal file
15
tests/Makefile.am
Normal file
@ -0,0 +1,15 @@
|
||||
# additional include paths necessary to compile the C++ library
|
||||
AM_CXXFLAGS = -I$(top_srcdir)/lib
|
||||
AM_LDFLAGS = -L$(top_srcdir)/lib
|
||||
|
||||
#
|
||||
# Test code
|
||||
#
|
||||
bin_PROGRAMS = Grid_main test_Grid_stencil
|
||||
|
||||
Grid_main_SOURCES = Grid_main.cc
|
||||
Grid_main_LDADD = -lGrid
|
||||
|
||||
test_Grid_stencil_SOURCES = test_Grid_stencil.cc
|
||||
test_Grid_stencil_LDADD = -lGrid
|
||||
|
206
tests/test_Grid_jacobi.cc
Normal file
206
tests/test_Grid_jacobi.cc
Normal file
@ -0,0 +1,206 @@
|
||||
#include "Grid.h"
|
||||
|
||||
using namespace std;
|
||||
using namespace Grid;
|
||||
using namespace Grid::QCD;
|
||||
|
||||
template<class vobj>
|
||||
class LinearOperator {
|
||||
public:
|
||||
operator () (const Lattice<vobj>&src,Lattice<vobj> &result) {};
|
||||
};
|
||||
|
||||
template<class vobj>
|
||||
class LinearOperatorJacobi : public LinearOperator<vobj>
|
||||
{
|
||||
CartesianStencil *Stencil;
|
||||
GridBase *_grid;
|
||||
std::vector<vobj,alignedAllocator<vobj> > comm_buf;
|
||||
LinearOperatorJacobi(GridCartesian *grid)
|
||||
{
|
||||
_grid = grid;
|
||||
int npoint=9;
|
||||
std::vector<int> directions(npoint);
|
||||
std::vector<int> displacements(npoint);
|
||||
for(int mu=0;mu<4;mu++){
|
||||
for(int mp=0;mp<2;mp++){
|
||||
int dir = 2*mu+mp;
|
||||
directions[dir] = mu;
|
||||
displacements[dir]= -1+2*mp;
|
||||
}
|
||||
}
|
||||
directions[8] = 0;
|
||||
displacements[8] = 0;
|
||||
|
||||
Stencil = new CartesianStencil(grid,npoint,0,directions,displacements);
|
||||
|
||||
comm_buf.resize(Stencil->_unified_buffer_size);
|
||||
|
||||
}
|
||||
operator () (const Lattice<vobj>&src,Lattice<vobj> &result)
|
||||
{
|
||||
const int npoint=9;
|
||||
printf("calling halo exchange\n");fflush(stdout);
|
||||
myStencil.HaloExchange(Foo,comm_buf);
|
||||
vobj tmp;
|
||||
vobj
|
||||
for(int i=0;i<_grid->oSites();i++){
|
||||
for(int p=0;p<npoint;p++){
|
||||
|
||||
int offset = Stencil->_offsets [p][i];
|
||||
int local = Stencil->_is_local[p][i];
|
||||
int ptype = Stencil->_permute_type[p];
|
||||
int perm = Stencil->_permute[0][i];
|
||||
|
||||
vobj *nbr;
|
||||
if ( local && perm ){
|
||||
permute(tmp,src._odata[offset],ptype);
|
||||
nbr = &tmp;
|
||||
} else if (local) {
|
||||
nbr = &src._odata[offset];
|
||||
} else {
|
||||
nbr = &comm_buf[offset];
|
||||
}
|
||||
result[i] = result[i]+*nbr;
|
||||
}
|
||||
}
|
||||
}
|
||||
~LinearOperatorJacobi()
|
||||
{
|
||||
delete Stencil;
|
||||
}
|
||||
}
|
||||
|
||||
int main (int argc, char ** argv)
|
||||
{
|
||||
Grid_init(&argc,&argv);
|
||||
|
||||
std::vector<int> latt_size (4);
|
||||
std::vector<int> simd_layout(4);
|
||||
std::vector<int> mpi_layout (4);
|
||||
|
||||
int omp=1;
|
||||
int lat=8;
|
||||
|
||||
mpi_layout[0]=1;
|
||||
mpi_layout[1]=2;
|
||||
mpi_layout[2]=1;
|
||||
mpi_layout[3]=1;
|
||||
|
||||
latt_size[0] = lat;
|
||||
latt_size[1] = lat;
|
||||
latt_size[2] = lat;
|
||||
latt_size[3] = lat;
|
||||
double volume = latt_size[0]*latt_size[1]*latt_size[2]*latt_size[3];
|
||||
|
||||
#ifdef AVX512
|
||||
simd_layout[0] = 1;
|
||||
simd_layout[1] = 2;
|
||||
simd_layout[2] = 2;
|
||||
simd_layout[3] = 2;
|
||||
#endif
|
||||
#if defined (AVX1)|| defined (AVX2)
|
||||
simd_layout[0] = 1;
|
||||
simd_layout[1] = 1;
|
||||
simd_layout[2] = 2;
|
||||
simd_layout[3] = 2;
|
||||
#endif
|
||||
#if defined (SSE2)
|
||||
simd_layout[0] = 1;
|
||||
simd_layout[1] = 1;
|
||||
simd_layout[2] = 1;
|
||||
simd_layout[3] = 2;
|
||||
#endif
|
||||
|
||||
GridCartesian Fine(latt_size,simd_layout,mpi_layout);
|
||||
GridRedBlackCartesian rbFine(latt_size,simd_layout,mpi_layout);
|
||||
|
||||
LatticeColourMatrix Foo(&Fine);
|
||||
LatticeColourMatrix Bar(&Fine);
|
||||
LatticeColourMatrix Check(&Fine);
|
||||
LatticeColourMatrix Diff(&Fine);
|
||||
|
||||
random(Foo);
|
||||
gaussian(Bar);
|
||||
|
||||
|
||||
for(int dir=0;dir<4;dir++){
|
||||
for(int disp=0;disp<Fine._rdimensions[dir];disp++){
|
||||
|
||||
// start to test the Cartesian npoint stencil infrastructure
|
||||
int npoint=;
|
||||
std::vector<int> directions(npoint,dir);
|
||||
std::vector<int> displacements(npoint,disp);
|
||||
|
||||
CartesianStencil myStencil(&Fine,npoint,0,directions,displacements);
|
||||
|
||||
printf("STENCIL: osites %d %d dir %d disp %d\n",Fine.oSites(),(int)myStencil._offsets[0].size(),dir,disp);
|
||||
std::vector<int> ocoor(4);
|
||||
for(int o=0;o<Fine.oSites();o++){
|
||||
Fine.oCoorFromOindex(ocoor,o);
|
||||
ocoor[dir]=(ocoor[dir]+disp)%Fine._rdimensions[dir];
|
||||
int nbr = Fine.oIndexReduced(ocoor);
|
||||
int stcl= myStencil._offsets[0][o];
|
||||
if(nbr!=stcl){
|
||||
printf("STENCIL: nbr %d stencil._offset %d\n",nbr,stcl);
|
||||
}
|
||||
}
|
||||
|
||||
printf("allocating %d buffers\n",myStencil._unified_buffer_size);
|
||||
fflush(stdout);
|
||||
std::vector<vColourMatrix,alignedAllocator<vColourMatrix> > comm_buf(myStencil._unified_buffer_size);
|
||||
printf("calling halo exchange\n");fflush(stdout);
|
||||
myStencil.HaloExchange(Foo,comm_buf);
|
||||
|
||||
Bar = Cshift(Foo,dir,disp);
|
||||
|
||||
// Implement a stencil code that should agree with cshift!
|
||||
for(int i=0;i<Check._grid->oSites();i++){
|
||||
|
||||
int offset = myStencil._offsets [0][i];
|
||||
int local = myStencil._is_local[0][i];
|
||||
int permute_type = myStencil._permute_type[0];
|
||||
int perm =myStencil._permute[0][i];
|
||||
if ( local && perm )
|
||||
permute(Check._odata[i],Foo._odata[offset],permute_type);
|
||||
else if (local)
|
||||
Check._odata[i] = Foo._odata[offset];
|
||||
else
|
||||
Check._odata[i] = comm_buf[offset];
|
||||
|
||||
|
||||
}
|
||||
|
||||
|
||||
std::vector<int> coor(4);
|
||||
for(coor[3]=0;coor[3]<latt_size[3]/mpi_layout[3];coor[3]++){
|
||||
for(coor[2]=0;coor[2]<latt_size[2]/mpi_layout[2];coor[2]++){
|
||||
for(coor[1]=0;coor[1]<latt_size[1]/mpi_layout[1];coor[1]++){
|
||||
for(coor[0]=0;coor[0]<latt_size[0]/mpi_layout[0];coor[0]++){
|
||||
|
||||
Complex diff;
|
||||
ColourMatrix check,bar;
|
||||
peekSite(check,Check,coor);
|
||||
peekSite(bar,Bar,coor);
|
||||
|
||||
for(int r=0;r<3;r++){
|
||||
for(int c=0;c<3;c++){
|
||||
diff =check._internal._internal[r][c]-bar._internal._internal[r][c];
|
||||
double nn=real(conj(diff)*diff);
|
||||
if ( nn > 0 ){
|
||||
printf("Coor (%d %d %d %d) \t rc %d%d \t %le %le %le\n",
|
||||
coor[0],coor[1],coor[2],coor[3],r,c,
|
||||
nn,
|
||||
real(check._internal._internal[r][c]),
|
||||
real(bar._internal._internal[r][c])
|
||||
);
|
||||
}
|
||||
}}
|
||||
|
||||
}}}}
|
||||
|
||||
}
|
||||
}
|
||||
|
||||
Grid_finalize();
|
||||
}
|
154
tests/test_Grid_stencil.cc
Normal file
154
tests/test_Grid_stencil.cc
Normal file
@ -0,0 +1,154 @@
|
||||
#include "Grid.h"
|
||||
|
||||
using namespace std;
|
||||
using namespace Grid;
|
||||
using namespace Grid::QCD;
|
||||
|
||||
|
||||
int main (int argc, char ** argv)
|
||||
{
|
||||
Grid_init(&argc,&argv);
|
||||
|
||||
std::vector<int> latt_size (4);
|
||||
std::vector<int> simd_layout(4);
|
||||
std::vector<int> mpi_layout (4);
|
||||
|
||||
int omp=1;
|
||||
int lat=8;
|
||||
|
||||
mpi_layout[0]=1;
|
||||
mpi_layout[1]=1;
|
||||
mpi_layout[2]=1;
|
||||
mpi_layout[3]=1;
|
||||
|
||||
latt_size[0] = lat;
|
||||
latt_size[1] = lat;
|
||||
latt_size[2] = lat;
|
||||
latt_size[3] = lat;
|
||||
double volume = latt_size[0]*latt_size[1]*latt_size[2]*latt_size[3];
|
||||
|
||||
#ifdef AVX512
|
||||
simd_layout[0] = 1;
|
||||
simd_layout[1] = 2;
|
||||
simd_layout[2] = 2;
|
||||
simd_layout[3] = 2;
|
||||
#endif
|
||||
#if defined (AVX1)|| defined (AVX2)
|
||||
simd_layout[0] = 1;
|
||||
simd_layout[1] = 1;
|
||||
simd_layout[2] = 2;
|
||||
simd_layout[3] = 2;
|
||||
#endif
|
||||
#if defined (SSE2)
|
||||
simd_layout[0] = 1;
|
||||
simd_layout[1] = 1;
|
||||
simd_layout[2] = 1;
|
||||
simd_layout[3] = 2;
|
||||
#endif
|
||||
|
||||
GridCartesian Fine(latt_size,simd_layout,mpi_layout);
|
||||
GridRedBlackCartesian rbFine(latt_size,simd_layout,mpi_layout);
|
||||
|
||||
LatticeColourMatrix Foo(&Fine);
|
||||
LatticeColourMatrix Bar(&Fine);
|
||||
LatticeColourMatrix Check(&Fine);
|
||||
LatticeColourMatrix Diff(&Fine);
|
||||
|
||||
random(Foo);
|
||||
gaussian(Bar);
|
||||
|
||||
|
||||
for(int dir=0;dir<4;dir++){
|
||||
for(int disp=0;disp<Fine._rdimensions[dir];disp++){
|
||||
|
||||
// start to test the Cartesian npoint stencil infrastructure
|
||||
int npoint=1;
|
||||
std::vector<int> directions(npoint,dir);
|
||||
std::vector<int> displacements(npoint,disp);
|
||||
|
||||
CartesianStencil myStencil(&Fine,npoint,0,directions,displacements);
|
||||
|
||||
printf("STENCIL: osites %d %d dir %d disp %d\n",Fine.oSites(),(int)myStencil._offsets[0].size(),dir,disp);
|
||||
std::vector<int> ocoor(4);
|
||||
for(int o=0;o<Fine.oSites();o++){
|
||||
Fine.oCoorFromOindex(ocoor,o);
|
||||
ocoor[dir]=(ocoor[dir]+disp)%Fine._rdimensions[dir];
|
||||
int nbr = Fine.oIndexReduced(ocoor);
|
||||
int stcl= myStencil._offsets[0][o];
|
||||
if(nbr!=stcl){
|
||||
printf("STENCIL: nbr %d stencil._offset %d\n",nbr,stcl);
|
||||
}
|
||||
}
|
||||
|
||||
printf("allocating %d buffers\n",myStencil._unified_buffer_size);
|
||||
fflush(stdout);
|
||||
std::vector<vColourMatrix,alignedAllocator<vColourMatrix> > comm_buf(myStencil._unified_buffer_size);
|
||||
printf("calling halo exchange\n");fflush(stdout);
|
||||
myStencil.HaloExchange(Foo,comm_buf);
|
||||
|
||||
Bar = Cshift(Foo,dir,disp);
|
||||
|
||||
// Implement a stencil code that should agree with cshift!
|
||||
for(int i=0;i<Check._grid->oSites();i++){
|
||||
|
||||
int offset = myStencil._offsets [0][i];
|
||||
int local = myStencil._is_local[0][i];
|
||||
int permute_type = myStencil._permute_type[0];
|
||||
int perm =myStencil._permute[0][i];
|
||||
if ( local && perm )
|
||||
permute(Check._odata[i],Foo._odata[offset],permute_type);
|
||||
else if (local)
|
||||
Check._odata[i] = Foo._odata[offset];
|
||||
else
|
||||
Check._odata[i] = comm_buf[offset];
|
||||
|
||||
|
||||
}
|
||||
|
||||
Real nrmC = norm2(Check);
|
||||
Real nrmB = norm2(Bar);
|
||||
Real nrm = norm2(Check-Bar);
|
||||
printf("N2diff = %le (%le, %le) \n",nrm,nrmC,nrmB);fflush(stdout);
|
||||
|
||||
Real snrmC =0;
|
||||
Real snrmB =0;
|
||||
Real snrm =0;
|
||||
|
||||
std::vector<int> coor(4);
|
||||
for(coor[3]=0;coor[3]<latt_size[3]/mpi_layout[3];coor[3]++){
|
||||
for(coor[2]=0;coor[2]<latt_size[2]/mpi_layout[2];coor[2]++){
|
||||
for(coor[1]=0;coor[1]<latt_size[1]/mpi_layout[1];coor[1]++){
|
||||
for(coor[0]=0;coor[0]<latt_size[0]/mpi_layout[0];coor[0]++){
|
||||
|
||||
Complex diff;
|
||||
ColourMatrix check,bar;
|
||||
peekSite(check,Check,coor);
|
||||
peekSite(bar,Bar,coor);
|
||||
|
||||
for(int r=0;r<3;r++){
|
||||
for(int c=0;c<3;c++){
|
||||
diff =check()()(r,c)-bar()()(r,c);
|
||||
double nn=real(conj(diff)*diff);
|
||||
if ( nn > 0){
|
||||
printf("Coor (%d %d %d %d) \t rc %d%d \t %le %le %le\n",
|
||||
coor[0],coor[1],coor[2],coor[3],r,c,
|
||||
nn,
|
||||
real(check()()(r,c)),
|
||||
real(bar()()(r,c))
|
||||
);
|
||||
}
|
||||
snrmC=snrmC+real(conj(check()()(r,c))*check()()(r,c));
|
||||
snrmB=snrmB+real(conj(bar()()(r,c))*bar()()(r,c));
|
||||
snrm=snrm+nn;
|
||||
}}
|
||||
|
||||
}}}}
|
||||
|
||||
printf("scalar N2diff = %le (%le, %le) \n",snrm,snrmC,snrmB);fflush(stdout);
|
||||
|
||||
|
||||
}
|
||||
}
|
||||
|
||||
Grid_finalize();
|
||||
}
|
Reference in New Issue
Block a user