mirror of
				https://github.com/paboyle/Grid.git
				synced 2025-11-04 14:04:32 +00:00 
			
		
		
		
	Extensive gamma test program
This commit is contained in:
		@@ -4,10 +4,11 @@
 | 
			
		||||
 | 
			
		||||
Source file: ./tests/Test_gamma.cc
 | 
			
		||||
 | 
			
		||||
    Copyright (C) 2015
 | 
			
		||||
Copyright (C) 2015-2017
 | 
			
		||||
 | 
			
		||||
Author: Azusa Yamaguchi <ayamaguc@staffmail.ed.ac.uk>
 | 
			
		||||
Author: Peter Boyle <paboyle@ph.ed.ac.uk>
 | 
			
		||||
Author: Antonin Portelli <antonin.portelli@ed.ac.uk>
 | 
			
		||||
 | 
			
		||||
This program is free software; you can redistribute it and/or modify
 | 
			
		||||
it under the terms of the GNU General Public License as published by
 | 
			
		||||
@@ -30,14 +31,175 @@ Author: Peter Boyle <paboyle@ph.ed.ac.uk>
 | 
			
		||||
 | 
			
		||||
using namespace std;
 | 
			
		||||
using namespace Grid;
 | 
			
		||||
using namespace Grid::QCD;
 | 
			
		||||
using namespace QCD;
 | 
			
		||||
 | 
			
		||||
//template<class vobj> class is_pod< iScalar<vobj> >
 | 
			
		||||
//{
 | 
			
		||||
//
 | 
			
		||||
//};
 | 
			
		||||
static constexpr double                      tolerance = 1.0e-6;
 | 
			
		||||
static std::array<SpinMatrix, Gamma::nGamma> testAlgebra;
 | 
			
		||||
 | 
			
		||||
int main (int argc, char ** argv)
 | 
			
		||||
void print(const SpinMatrix &g)
 | 
			
		||||
{
 | 
			
		||||
  for(int i = 0; i < Ns; i++)
 | 
			
		||||
  {
 | 
			
		||||
    std::cout << GridLogMessage << "(";
 | 
			
		||||
    for(int j=0;j<Ns;j++){
 | 
			
		||||
      if ( abs(g()(i,j)()) == 0 ) {
 | 
			
		||||
        std::cout<< " 0";
 | 
			
		||||
      } else if ( abs(g()(i,j)() - Complex(0,1)) == 0){
 | 
			
		||||
        std::cout<< " i";
 | 
			
		||||
      } else if ( abs(g()(i,j)() + Complex(0,1)) == 0){
 | 
			
		||||
        std::cout<< "-i";
 | 
			
		||||
      } else if ( abs(g()(i,j)() - Complex(1,0)) == 0){
 | 
			
		||||
        std::cout<< " 1";
 | 
			
		||||
      } else if ( abs(g()(i,j)() + Complex(1,0)) == 0){
 | 
			
		||||
        std::cout<< "-1";
 | 
			
		||||
      }
 | 
			
		||||
      std::cout<<((j == Ns-1) ? ")" : "," );
 | 
			
		||||
    }
 | 
			
		||||
    std::cout << std::endl;
 | 
			
		||||
  }
 | 
			
		||||
  std::cout << GridLogMessage << std::endl;
 | 
			
		||||
}
 | 
			
		||||
 | 
			
		||||
void createTestAlgebra(void)
 | 
			
		||||
{
 | 
			
		||||
  std::array<SpinMatrix, 4> testg;
 | 
			
		||||
  SpinMatrix                testg5;
 | 
			
		||||
  const Complex             I(0., 1.), mI(0., -1.);
 | 
			
		||||
  
 | 
			
		||||
  testg[0] = zero;
 | 
			
		||||
  testg[0]()(0, 3) = I;
 | 
			
		||||
  testg[0]()(1, 2) = I;
 | 
			
		||||
  testg[0]()(2, 1) = mI;
 | 
			
		||||
  testg[0]()(3, 0) = mI;
 | 
			
		||||
  std::cout << GridLogMessage << "test GammaX= " << std::endl;
 | 
			
		||||
  print(testg[0]);
 | 
			
		||||
  testg[1] = zero;
 | 
			
		||||
  testg[1]()(0, 3) = -1.;
 | 
			
		||||
  testg[1]()(1, 2) = 1.;
 | 
			
		||||
  testg[1]()(2, 1) = 1.;
 | 
			
		||||
  testg[1]()(3, 0) = -1.;
 | 
			
		||||
  std::cout << GridLogMessage << "test GammaY= " << std::endl;
 | 
			
		||||
  print(testg[1]);
 | 
			
		||||
  testg[2] = zero;
 | 
			
		||||
  testg[2]()(0, 2) = I;
 | 
			
		||||
  testg[2]()(1, 3) = mI;
 | 
			
		||||
  testg[2]()(2, 0) = mI;
 | 
			
		||||
  testg[2]()(3, 1) = I;
 | 
			
		||||
  std::cout << GridLogMessage << "test GammaZ= " << std::endl;
 | 
			
		||||
  print(testg[2]);
 | 
			
		||||
  testg[3] = zero;
 | 
			
		||||
  testg[3]()(0, 2) = 1.;
 | 
			
		||||
  testg[3]()(1, 3) = 1.;
 | 
			
		||||
  testg[3]()(2, 0) = 1.;
 | 
			
		||||
  testg[3]()(3, 1) = 1.;
 | 
			
		||||
  std::cout << GridLogMessage << "test GammaT= " << std::endl;
 | 
			
		||||
  print(testg[3]);
 | 
			
		||||
  testg5 = testg[0]*testg[1]*testg[2]*testg[3];
 | 
			
		||||
  
 | 
			
		||||
#define DEFINE_TEST_G(g, exp)\
 | 
			
		||||
testAlgebra[Gamma::Algebra::g]        = exp;\
 | 
			
		||||
testAlgebra[Gamma::Algebra::Minus##g] = -exp;\
 | 
			
		||||
  
 | 
			
		||||
  DEFINE_TEST_G(Identity    , 1.);
 | 
			
		||||
  DEFINE_TEST_G(Gamma5      , testg5);
 | 
			
		||||
  DEFINE_TEST_G(GammaX      , testg[0]);
 | 
			
		||||
  DEFINE_TEST_G(GammaY      , testg[1]);
 | 
			
		||||
  DEFINE_TEST_G(GammaZ      , testg[2]);
 | 
			
		||||
  DEFINE_TEST_G(GammaT      , testg[3]);
 | 
			
		||||
  DEFINE_TEST_G(GammaXGamma5, testg[0]*testg5);
 | 
			
		||||
  DEFINE_TEST_G(GammaYGamma5, testg[1]*testg5);
 | 
			
		||||
  DEFINE_TEST_G(GammaZGamma5, testg[2]*testg5);
 | 
			
		||||
  DEFINE_TEST_G(GammaTGamma5, testg[3]*testg5);
 | 
			
		||||
  DEFINE_TEST_G(SigmaXY     , .5*(testg[0]*testg[1] - testg[1]*testg[0]));
 | 
			
		||||
  DEFINE_TEST_G(SigmaXZ     , .5*(testg[0]*testg[2] - testg[2]*testg[0]));
 | 
			
		||||
  DEFINE_TEST_G(SigmaXT     , .5*(testg[0]*testg[3] - testg[3]*testg[0]));
 | 
			
		||||
  DEFINE_TEST_G(SigmaYZ     , .5*(testg[1]*testg[2] - testg[2]*testg[1]));
 | 
			
		||||
  DEFINE_TEST_G(SigmaYT     , .5*(testg[1]*testg[3] - testg[3]*testg[1]));
 | 
			
		||||
  DEFINE_TEST_G(SigmaZT     , .5*(testg[2]*testg[3] - testg[3]*testg[2]));
 | 
			
		||||
  
 | 
			
		||||
#undef DEFINE_TEST_G
 | 
			
		||||
}
 | 
			
		||||
 | 
			
		||||
template <typename Expr>
 | 
			
		||||
void test(const Expr &a, const Expr &b)
 | 
			
		||||
{
 | 
			
		||||
  if (norm2(a - b) < tolerance)
 | 
			
		||||
  {
 | 
			
		||||
    std::cout << "[OK] ";
 | 
			
		||||
  }
 | 
			
		||||
  else
 | 
			
		||||
  {
 | 
			
		||||
    std::cout << "[fail]" << std::endl;
 | 
			
		||||
    std::cout << GridLogError << "a= " << a << std::endl;
 | 
			
		||||
    std::cout << GridLogError << "is different (tolerance= " << tolerance << ") from " << std::endl;
 | 
			
		||||
    std::cout << GridLogError << "b= " << b << std::endl;
 | 
			
		||||
    exit(EXIT_FAILURE);
 | 
			
		||||
  }
 | 
			
		||||
}
 | 
			
		||||
 | 
			
		||||
void checkMat(const Gamma::Algebra a, GridSerialRNG &rng)
 | 
			
		||||
{
 | 
			
		||||
  SpinVector v;
 | 
			
		||||
  SpinMatrix m, &testg = testAlgebra[a];
 | 
			
		||||
  Gamma      g(a);
 | 
			
		||||
  bool       pass = true;
 | 
			
		||||
  
 | 
			
		||||
  random(rng, v);
 | 
			
		||||
  random(rng, m);
 | 
			
		||||
  
 | 
			
		||||
  std::cout << GridLogMessage << "Checking " << Gamma::name[a] << ": ";
 | 
			
		||||
  std::cout << "vecmul ";
 | 
			
		||||
  test(g*v, testg*v);
 | 
			
		||||
  std::cout << "matlmul ";
 | 
			
		||||
  test(g*m, testg*m);
 | 
			
		||||
  std::cout << "matrmul ";
 | 
			
		||||
  test(m*g, m*testg);
 | 
			
		||||
  std::cout << std::endl;
 | 
			
		||||
}
 | 
			
		||||
 | 
			
		||||
void checkProd(const Gamma::Algebra a, const Gamma::Algebra b)
 | 
			
		||||
{
 | 
			
		||||
  SpinMatrix gm, testg = testAlgebra[a]*testAlgebra[b];
 | 
			
		||||
  Gamma      ga(a), gb(b), g = ga*gb;
 | 
			
		||||
  bool       pass = true;
 | 
			
		||||
  
 | 
			
		||||
  std::cout << GridLogMessage << "Checking " << Gamma::name[a] << " * "
 | 
			
		||||
            << Gamma::name[b] << ": ";
 | 
			
		||||
  gm = 1.0;
 | 
			
		||||
  gm = g*gm;
 | 
			
		||||
  test(gm, testg);
 | 
			
		||||
  std::cout << "(= " << Gamma::name[g.g] << ")" << std::endl;
 | 
			
		||||
}
 | 
			
		||||
 | 
			
		||||
void checkProject(GridSerialRNG &rng)
 | 
			
		||||
{
 | 
			
		||||
  SpinVector     rv, recon, full;
 | 
			
		||||
  HalfSpinVector hsp, hsm;
 | 
			
		||||
  
 | 
			
		||||
  random(rng, rv);
 | 
			
		||||
  
 | 
			
		||||
#define CHECK_PROJ(dir, gamma)\
 | 
			
		||||
std::cout << GridLogMessage << "Checking " << #dir << " projector: ";\
 | 
			
		||||
spProj##dir(hsm,rv);\
 | 
			
		||||
spRecon##dir(recon,hsm);\
 | 
			
		||||
test(recon, rv + Gamma(Gamma::Algebra::gamma)*rv);\
 | 
			
		||||
std::cout << std::endl;
 | 
			
		||||
  
 | 
			
		||||
  CHECK_PROJ(Xp, GammaX);
 | 
			
		||||
  CHECK_PROJ(Yp, GammaY);
 | 
			
		||||
  CHECK_PROJ(Zp, GammaZ);
 | 
			
		||||
  CHECK_PROJ(Tp, GammaT);
 | 
			
		||||
  CHECK_PROJ(5p, Gamma5);
 | 
			
		||||
  CHECK_PROJ(Xm, MinusGammaX);
 | 
			
		||||
  CHECK_PROJ(Ym, MinusGammaY);
 | 
			
		||||
  CHECK_PROJ(Zm, MinusGammaZ);
 | 
			
		||||
  CHECK_PROJ(Tm, MinusGammaT);
 | 
			
		||||
  CHECK_PROJ(5m, MinusGamma5);
 | 
			
		||||
  
 | 
			
		||||
#undef CHECK_PROJ
 | 
			
		||||
}
 | 
			
		||||
 | 
			
		||||
int main(int argc, char *argv[])
 | 
			
		||||
{
 | 
			
		||||
  Grid_init(&argc,&argv);
 | 
			
		||||
  
 | 
			
		||||
@@ -46,178 +208,29 @@ int main (int argc, char ** argv)
 | 
			
		||||
  std::vector<int> mpi_layout  = GridDefaultMpi();
 | 
			
		||||
  
 | 
			
		||||
  GridCartesian Grid(latt_size,simd_layout,mpi_layout);
 | 
			
		||||
 | 
			
		||||
  GridParallelRNG          pRNG(&Grid);
 | 
			
		||||
  pRNG.SeedRandomDevice();
 | 
			
		||||
 | 
			
		||||
  GridSerialRNG sRNG;
 | 
			
		||||
  
 | 
			
		||||
  sRNG.SeedRandomDevice();
 | 
			
		||||
  
 | 
			
		||||
  SpinMatrix ident; ident=zero;
 | 
			
		||||
  SpinMatrix rnd  ; random(sRNG,rnd);
 | 
			
		||||
 | 
			
		||||
  SpinMatrix ll; ll=zero;
 | 
			
		||||
  SpinMatrix rr; rr=zero;
 | 
			
		||||
  SpinMatrix result;
 | 
			
		||||
 | 
			
		||||
  SpinVector lv; random(sRNG,lv);
 | 
			
		||||
  SpinVector rv; random(sRNG,rv);
 | 
			
		||||
 | 
			
		||||
  //  std::cout<<GridLogMessage << " Is pod " << std::is_pod<SpinVector>::value  << std::endl;
 | 
			
		||||
  //  std::cout<<GridLogMessage << " Is pod double   " << std::is_pod<double>::value  << std::endl;
 | 
			
		||||
  //  std::cout<<GridLogMessage << " Is pod ComplexF " << std::is_pod<ComplexF>::value  << std::endl;
 | 
			
		||||
  //  std::cout<<GridLogMessage << " Is triv double " << std::has_trivial_default_constructor<double>::value  << std::endl;
 | 
			
		||||
  //  std::cout<<GridLogMessage << " Is triv ComplexF " << std::has_trivial_default_constructor<ComplexF>::value  << std::endl;
 | 
			
		||||
  //  std::cout<<GridLogMessage << " Is pod Scalar<double> " << std::is_pod<iScalar<double> >::value  << std::endl;
 | 
			
		||||
  //  std::cout<<GridLogMessage << " Is pod Scalar<ComplexF> " << std::is_pod<iScalar<ComplexF> >::value  << std::endl;
 | 
			
		||||
  //  std::cout<<GridLogMessage << " Is pod Scalar<vComplexF> " << std::is_pod<iScalar<vComplexF> >::value  << std::endl;
 | 
			
		||||
  //  std::cout<<GridLogMessage << " Is pod Scalar<vComplexD> " << std::is_pod<iScalar<vComplexD> >::value  << std::endl;
 | 
			
		||||
  //  std::cout<<GridLogMessage << " Is pod Scalar<vRealF> " << std::is_pod<iScalar<vRealF> >::value  << std::endl;
 | 
			
		||||
  //  std::cout<<GridLogMessage << " Is pod Scalar<vRealD> " << std::is_pod<iScalar<vRealD> >::value  << std::endl;
 | 
			
		||||
  //  std::cout<<GridLogMessage << " Is triv Scalar<double> " <<std::has_trivial_default_constructor<iScalar<double> >::value << std::endl;
 | 
			
		||||
  //  std::cout<<GridLogMessage << " Is triv Scalar<vComplexD> "<<std::has_trivial_default_constructor<iScalar<vComplexD> >::value  << std::endl;
 | 
			
		||||
 | 
			
		||||
  for(int a=0;a<Ns;a++){
 | 
			
		||||
    ident()(a,a) = ComplexF(1.0);
 | 
			
		||||
  std::cout << GridLogMessage << "======== Test algebra" << std::endl;
 | 
			
		||||
  createTestAlgebra();
 | 
			
		||||
  std::cout << GridLogMessage << "======== Multiplication operators check" << std::endl;
 | 
			
		||||
  for (int i = 0; i < Gamma::nGamma; ++i)
 | 
			
		||||
  {
 | 
			
		||||
    checkMat(i, sRNG);
 | 
			
		||||
  }
 | 
			
		||||
 | 
			
		||||
  const Gamma::Algebra *g = Gamma::GammaMatrices;
 | 
			
		||||
  const char **list           = Gamma::GammaMatrixNames;
 | 
			
		||||
 | 
			
		||||
  result =ll*Gamma(g[0])*rr;
 | 
			
		||||
  result =ll*Gamma(g[0]);
 | 
			
		||||
  rv = Gamma(g[0])*lv;
 | 
			
		||||
 | 
			
		||||
  for(int mu=0;mu<12;mu++){
 | 
			
		||||
 | 
			
		||||
    result = Gamma(g[mu])* ident;
 | 
			
		||||
 | 
			
		||||
    for(int i=0;i<Ns;i++){
 | 
			
		||||
 | 
			
		||||
      if(i==0) std::cout<<GridLogMessage << list[mu];
 | 
			
		||||
      else     std::cout<<GridLogMessage << list[12];
 | 
			
		||||
 | 
			
		||||
      std::cout<<"(";
 | 
			
		||||
      for(int j=0;j<Ns;j++){
 | 
			
		||||
	if ( abs(result()(i,j)())==0 ) {
 | 
			
		||||
	  std::cout<< " 0";
 | 
			
		||||
	} else if ( abs(result()(i,j)() - Complex(0,1))==0){
 | 
			
		||||
	  std::cout<< " i";
 | 
			
		||||
	} else if ( abs(result()(i,j)() + Complex(0,1))==0){
 | 
			
		||||
	  std::cout<< "-i";
 | 
			
		||||
	} else if ( abs(result()(i,j)() - Complex(1,0))==0){
 | 
			
		||||
	  std::cout<< " 1";
 | 
			
		||||
	} else if ( abs(result()(i,j)() + Complex(1,0))==0){
 | 
			
		||||
	  std::cout<< "-1";
 | 
			
		||||
  std::cout << GridLogMessage << std::endl;
 | 
			
		||||
  std::cout << GridLogMessage << "======== Algebra multiplication table check" << std::endl;
 | 
			
		||||
  for (int i = 0; i < Gamma::nGamma; ++i)
 | 
			
		||||
  for (int j = 0; j < Gamma::nGamma; ++j)
 | 
			
		||||
  {
 | 
			
		||||
    checkProd(i, j);
 | 
			
		||||
  }
 | 
			
		||||
	std::cout<<((j==Ns-1) ? ")" : "," );
 | 
			
		||||
      }
 | 
			
		||||
      std::cout << std::endl;
 | 
			
		||||
    }
 | 
			
		||||
 | 
			
		||||
    std::cout << std::endl;
 | 
			
		||||
 | 
			
		||||
  }
 | 
			
		||||
 | 
			
		||||
  std::cout << "Testing Gamma^2 - 1 = 0"<<std::endl;
 | 
			
		||||
  for(int mu=0;mu<6;mu++){
 | 
			
		||||
    result =  Gamma(g[mu])* ident * Gamma(g[mu]);
 | 
			
		||||
    result = result - ident;
 | 
			
		||||
    RealD mag = norm2(result);
 | 
			
		||||
    std::cout << list[mu]<<" " << mag<<std::endl;
 | 
			
		||||
  }
 | 
			
		||||
 | 
			
		||||
  std::cout << "Testing (MinusGamma + G )M = 0"<<std::endl;
 | 
			
		||||
  for(int mu=0;mu<6;mu++){
 | 
			
		||||
    result =          rnd * Gamma(g[mu]);
 | 
			
		||||
    result = result + rnd * Gamma(g[mu+6]);
 | 
			
		||||
    RealD mag = norm2(result);
 | 
			
		||||
    std::cout << list[mu]<<" " << mag<<std::endl;
 | 
			
		||||
  }
 | 
			
		||||
 | 
			
		||||
  std::cout << "Testing M(MinusGamma + G )  = 0"<<std::endl;
 | 
			
		||||
  for(int mu=0;mu<6;mu++){
 | 
			
		||||
    result =           Gamma(g[mu])  *rnd;
 | 
			
		||||
    result = result +  Gamma(g[mu+6])*rnd;
 | 
			
		||||
    RealD mag = norm2(result);
 | 
			
		||||
    std::cout << list[mu]<<" " << mag<<std::endl;
 | 
			
		||||
  }
 | 
			
		||||
 | 
			
		||||
  // Testing spins and reconstructs
 | 
			
		||||
  SpinVector     recon; random(sRNG,rv);
 | 
			
		||||
  SpinVector      full;
 | 
			
		||||
  HalfSpinVector hsp,hsm;
 | 
			
		||||
 | 
			
		||||
  // Xp
 | 
			
		||||
  double mag;
 | 
			
		||||
  spProjXp(hsm,rv);
 | 
			
		||||
  spReconXp(recon,hsm);
 | 
			
		||||
  full = rv + Gamma(Gamma::Algebra::GammaX) *rv;
 | 
			
		||||
  mag = TensorRemove(norm2(full-recon));
 | 
			
		||||
  std::cout << "Xp "<< mag<<std::endl;
 | 
			
		||||
 | 
			
		||||
  // Xm
 | 
			
		||||
  spProjXm(hsm,rv);
 | 
			
		||||
  spReconXm(recon,hsm);
 | 
			
		||||
  full = rv - Gamma(Gamma::Algebra::GammaX) *rv;
 | 
			
		||||
  mag = TensorRemove(norm2(full-recon));
 | 
			
		||||
  std::cout << "Xm "<< mag<<std::endl;
 | 
			
		||||
 | 
			
		||||
  // Yp
 | 
			
		||||
  spProjYp(hsm,rv);
 | 
			
		||||
  spReconYp(recon,hsm);
 | 
			
		||||
  full = rv + Gamma(Gamma::Algebra::GammaY) *rv;
 | 
			
		||||
  mag = TensorRemove(norm2(full-recon));
 | 
			
		||||
  std::cout << "Yp "<< mag<<std::endl;
 | 
			
		||||
 | 
			
		||||
  // Ym
 | 
			
		||||
  spProjYm(hsm,rv);
 | 
			
		||||
  spReconYm(recon,hsm);
 | 
			
		||||
  full = rv - Gamma(Gamma::Algebra::GammaY) *rv;
 | 
			
		||||
  mag = TensorRemove(norm2(full-recon));
 | 
			
		||||
  std::cout << "Ym "<< mag<<std::endl;
 | 
			
		||||
 | 
			
		||||
  // Zp
 | 
			
		||||
  spProjZp(hsm,rv);
 | 
			
		||||
  spReconZp(recon,hsm);
 | 
			
		||||
  full = rv + Gamma(Gamma::Algebra::GammaZ) *rv;
 | 
			
		||||
  mag = TensorRemove(norm2(full-recon));
 | 
			
		||||
  std::cout << "Zp "<< mag<<std::endl;
 | 
			
		||||
 | 
			
		||||
  // Zm
 | 
			
		||||
  spProjZm(hsm,rv);
 | 
			
		||||
  spReconZm(recon,hsm);
 | 
			
		||||
  full = rv - Gamma(Gamma::Algebra::GammaZ) *rv;
 | 
			
		||||
  mag = TensorRemove(norm2(full-recon));
 | 
			
		||||
  std::cout << "Zm "<< mag<<std::endl;
 | 
			
		||||
 | 
			
		||||
  // Tp
 | 
			
		||||
  spProjTp(hsm,rv);
 | 
			
		||||
  spReconTp(recon,hsm);
 | 
			
		||||
  full = rv + Gamma(Gamma::Algebra::GammaT) *rv;
 | 
			
		||||
  mag = TensorRemove(norm2(full-recon));
 | 
			
		||||
  std::cout << "Tp "<< mag<<std::endl;
 | 
			
		||||
 | 
			
		||||
  // Tm
 | 
			
		||||
  spProjTm(hsm,rv);
 | 
			
		||||
  spReconTm(recon,hsm);
 | 
			
		||||
  full = rv - Gamma(Gamma::Algebra::GammaT) *rv;
 | 
			
		||||
  mag = TensorRemove(norm2(full-recon));
 | 
			
		||||
  std::cout << "Tm "<< mag<<std::endl;
 | 
			
		||||
 | 
			
		||||
  // 5p
 | 
			
		||||
  spProj5p(hsm,rv);
 | 
			
		||||
  spRecon5p(recon,hsm);
 | 
			
		||||
  full = rv + Gamma(Gamma::Algebra::Gamma5) *rv;
 | 
			
		||||
  mag = TensorRemove(norm2(full-recon));
 | 
			
		||||
  std::cout << "5p "<< mag<<std::endl;
 | 
			
		||||
 | 
			
		||||
  // 5m
 | 
			
		||||
  spProj5m(hsm,rv);
 | 
			
		||||
  spRecon5m(recon,hsm);
 | 
			
		||||
  full = rv - Gamma(Gamma::Algebra::Gamma5) *rv;
 | 
			
		||||
  mag = TensorRemove(norm2(full-recon));
 | 
			
		||||
  std::cout << "5m "<< mag<<std::endl;
 | 
			
		||||
  std::cout << GridLogMessage << std::endl;
 | 
			
		||||
  std::cout << GridLogMessage << "======== Spin projectors check" << std::endl;
 | 
			
		||||
  checkProject(sRNG);
 | 
			
		||||
  
 | 
			
		||||
  Grid_finalize();
 | 
			
		||||
  
 | 
			
		||||
  return EXIT_SUCCESS;
 | 
			
		||||
}
 | 
			
		||||
 
 | 
			
		||||
		Reference in New Issue
	
	Block a user