mirror of
				https://github.com/paboyle/Grid.git
				synced 2025-10-25 10:09:34 +01:00 
			
		
		
		
	Compare commits
	
		
			9 Commits
		
	
	
		
			feature/su
			...
			feature/ha
		
	
	| Author | SHA1 | Date | |
|---|---|---|---|
|  | e307bb7528 | ||
|  | 5b8b630919 | ||
|  | 81287133f3 | ||
|  | bd27940f78 | ||
|  | d45647698d | ||
|  | d6ac6e75cc | ||
|  | ba34d7b206 | ||
|  | 80003787c9 | ||
|  | f523dddef0 | 
| @@ -24,6 +24,11 @@ class A2AModesSchurDiagTwo | |||||||
|     const bool return_5d; |     const bool return_5d; | ||||||
|  |  | ||||||
|   public: |   public: | ||||||
|  |  | ||||||
|  |   int getNl (void ) {return Nl;} | ||||||
|  |   int getNh (void ) {return Nh;} | ||||||
|  |   int getN  (void ) {return Nh+Nl;} | ||||||
|  |  | ||||||
|     A2AModesSchurDiagTwo(const std::vector<Field> *_evec, const std::vector<RealD> *_eval, |     A2AModesSchurDiagTwo(const std::vector<Field> *_evec, const std::vector<RealD> *_eval, | ||||||
|                          Matrix &_action, |                          Matrix &_action, | ||||||
|                          Solver &_solver, |                          Solver &_solver, | ||||||
|   | |||||||
| @@ -41,6 +41,7 @@ | |||||||
| #include <Grid/Hadrons/Modules/MContraction/MesonFieldGamma.hpp> | #include <Grid/Hadrons/Modules/MContraction/MesonFieldGamma.hpp> | ||||||
| #include <Grid/Hadrons/Modules/MContraction/WeakHamiltonianEye.hpp> | #include <Grid/Hadrons/Modules/MContraction/WeakHamiltonianEye.hpp> | ||||||
| #include <Grid/Hadrons/Modules/MContraction/Baryon.hpp> | #include <Grid/Hadrons/Modules/MContraction/Baryon.hpp> | ||||||
|  | #include <Grid/Hadrons/Modules/MContraction/A2APionField.hpp> | ||||||
| #include <Grid/Hadrons/Modules/MContraction/Meson.hpp> | #include <Grid/Hadrons/Modules/MContraction/Meson.hpp> | ||||||
| #include <Grid/Hadrons/Modules/MContraction/WeakHamiltonian.hpp> | #include <Grid/Hadrons/Modules/MContraction/WeakHamiltonian.hpp> | ||||||
| #include <Grid/Hadrons/Modules/MContraction/WeakNeutral4ptDisc.hpp> | #include <Grid/Hadrons/Modules/MContraction/WeakNeutral4ptDisc.hpp> | ||||||
|   | |||||||
| @@ -6,7 +6,7 @@ | |||||||
| #include <Grid/Hadrons/ModuleFactory.hpp> | #include <Grid/Hadrons/ModuleFactory.hpp> | ||||||
| #include <Grid/Hadrons/AllToAllVectors.hpp> | #include <Grid/Hadrons/AllToAllVectors.hpp> | ||||||
|  |  | ||||||
| #include <unsupported/Eigen/CXX11/Tensor> | #include <Grid/Hadrons/Modules/MContraction/A2Autils.hpp> | ||||||
|  |  | ||||||
| BEGIN_HADRONS_NAMESPACE | BEGIN_HADRONS_NAMESPACE | ||||||
|  |  | ||||||
| @@ -53,17 +53,6 @@ class TA2AMesonField : public Module<A2AMesonFieldPar> | |||||||
|     // execution |     // execution | ||||||
|     virtual void execute(void); |     virtual void execute(void); | ||||||
|  |  | ||||||
|     // Arithmetic help. Move to Grid?? |  | ||||||
|     virtual void MesonField(Eigen::Tensor<ComplexD,5> &mat,  |  | ||||||
| 			    const LatticeFermion *lhs, |  | ||||||
| 			    const LatticeFermion *rhs, |  | ||||||
| 			    std::vector<Gamma::Algebra> gammas, |  | ||||||
| 			    const std::vector<LatticeComplex > &mom, |  | ||||||
| 			    int orthogdim, |  | ||||||
| 			    double &t0, |  | ||||||
| 			    double &t1, |  | ||||||
| 			    double &t2, |  | ||||||
| 			    double &t3);       |  | ||||||
| }; | }; | ||||||
|  |  | ||||||
| MODULE_REGISTER(A2AMesonField, ARG(TA2AMesonField<FIMPL>), MContraction); | MODULE_REGISTER(A2AMesonField, ARG(TA2AMesonField<FIMPL>), MContraction); | ||||||
| @@ -117,189 +106,6 @@ void TA2AMesonField<FImpl>::setup(void) | |||||||
|     envTmpLat(FermionField, "tmp_5d", Ls_); |     envTmpLat(FermionField, "tmp_5d", Ls_); | ||||||
| } | } | ||||||
|  |  | ||||||
|  |  | ||||||
| ////////////////////////////////////////////////////////////////////////////////// |  | ||||||
| // Cache blocked arithmetic routine |  | ||||||
| // Could move to Grid ??? |  | ||||||
| ////////////////////////////////////////////////////////////////////////////////// |  | ||||||
| template <typename FImpl> |  | ||||||
| void TA2AMesonField<FImpl>::MesonField(Eigen::Tensor<ComplexD,5> &mat,  |  | ||||||
| 					 const LatticeFermion *lhs_wi, |  | ||||||
| 					 const LatticeFermion *rhs_vj, |  | ||||||
| 					 std::vector<Gamma::Algebra> gammas, |  | ||||||
| 					 const std::vector<LatticeComplex > &mom, |  | ||||||
| 					 int orthogdim, |  | ||||||
| 					 double &t0, |  | ||||||
| 					 double &t1, |  | ||||||
| 					 double &t2, |  | ||||||
| 					 double &t3)  |  | ||||||
| { |  | ||||||
|   typedef typename FImpl::SiteSpinor vobj; |  | ||||||
|  |  | ||||||
|   typedef typename vobj::scalar_object sobj; |  | ||||||
|   typedef typename vobj::scalar_type scalar_type; |  | ||||||
|   typedef typename vobj::vector_type vector_type; |  | ||||||
|  |  | ||||||
|   typedef iSpinMatrix<vector_type> SpinMatrix_v; |  | ||||||
|   typedef iSpinMatrix<scalar_type> SpinMatrix_s; |  | ||||||
|    |  | ||||||
|   int Lblock = mat.dimension(3);  |  | ||||||
|   int Rblock = mat.dimension(4); |  | ||||||
|  |  | ||||||
|   GridBase *grid = lhs_wi[0]._grid; |  | ||||||
|    |  | ||||||
|   const int    Nd = grid->_ndimension; |  | ||||||
|   const int Nsimd = grid->Nsimd(); |  | ||||||
|  |  | ||||||
|   int Nt     = grid->GlobalDimensions()[orthogdim]; |  | ||||||
|   int Ngamma = gammas.size(); |  | ||||||
|   int Nmom   = mom.size(); |  | ||||||
|  |  | ||||||
|   int fd=grid->_fdimensions[orthogdim]; |  | ||||||
|   int ld=grid->_ldimensions[orthogdim]; |  | ||||||
|   int rd=grid->_rdimensions[orthogdim]; |  | ||||||
|  |  | ||||||
|   // will locally sum vectors first |  | ||||||
|   // sum across these down to scalars |  | ||||||
|   // splitting the SIMD |  | ||||||
|   int MFrvol = rd*Lblock*Rblock*Nmom; |  | ||||||
|   int MFlvol = ld*Lblock*Rblock*Nmom; |  | ||||||
|  |  | ||||||
|   Vector<SpinMatrix_v > lvSum(MFrvol); |  | ||||||
|   parallel_for (int r = 0; r < MFrvol; r++){ |  | ||||||
|     lvSum[r] = zero; |  | ||||||
|   } |  | ||||||
|  |  | ||||||
|   Vector<SpinMatrix_s > lsSum(MFlvol);              |  | ||||||
|   parallel_for (int r = 0; r < MFlvol; r++){ |  | ||||||
|     lsSum[r]=scalar_type(0.0); |  | ||||||
|   } |  | ||||||
|  |  | ||||||
|   int e1=    grid->_slice_nblock[orthogdim]; |  | ||||||
|   int e2=    grid->_slice_block [orthogdim]; |  | ||||||
|   int stride=grid->_slice_stride[orthogdim]; |  | ||||||
|  |  | ||||||
|   t0-=usecond(); |  | ||||||
|   // Nested parallelism would be ok |  | ||||||
|   // Wasting cores here. Test case r |  | ||||||
|   parallel_for(int r=0;r<rd;r++){ |  | ||||||
|  |  | ||||||
|     int so=r*grid->_ostride[orthogdim]; // base offset for start of plane  |  | ||||||
|  |  | ||||||
|     for(int n=0;n<e1;n++){ |  | ||||||
|       for(int b=0;b<e2;b++){ |  | ||||||
|  |  | ||||||
| 	int ss= so+n*stride+b; |  | ||||||
|  |  | ||||||
| 	for(int i=0;i<Lblock;i++){ |  | ||||||
|  |  | ||||||
| 	  auto left = conjugate(lhs_wi[i]._odata[ss]); |  | ||||||
|  |  | ||||||
| 	  for(int j=0;j<Rblock;j++){ |  | ||||||
|  |  | ||||||
| 	    SpinMatrix_v vv; |  | ||||||
| 	    auto right = rhs_vj[j]._odata[ss]; |  | ||||||
| 	    for(int s1=0;s1<Ns;s1++){ |  | ||||||
| 	    for(int s2=0;s2<Ns;s2++){ |  | ||||||
| 	      vv()(s1,s2)() = left()(s2)(0) * right()(s1)(0) |  | ||||||
| 		+             left()(s2)(1) * right()(s1)(1) |  | ||||||
| 		+             left()(s2)(2) * right()(s1)(2); |  | ||||||
| 	    }} |  | ||||||
| 	     |  | ||||||
| 	    // After getting the sitewise product do the mom phase loop |  | ||||||
| 	    int base = Nmom*i+Nmom*Lblock*j+Nmom*Lblock*Rblock*r; |  | ||||||
| 	    for ( int m=0;m<Nmom;m++){ |  | ||||||
| 	      int idx = m+base; |  | ||||||
| 	      auto phase = mom[m]._odata[ss]; |  | ||||||
| 	      mac(&lvSum[idx],&vv,&phase); |  | ||||||
| 	    } |  | ||||||
| 	   |  | ||||||
| 	  } |  | ||||||
| 	} |  | ||||||
|       } |  | ||||||
|     } |  | ||||||
|   } |  | ||||||
|   t0+=usecond(); |  | ||||||
|  |  | ||||||
|  |  | ||||||
|   // Sum across simd lanes in the plane, breaking out orthog dir. |  | ||||||
|   t1-=usecond(); |  | ||||||
|   parallel_for(int rt=0;rt<rd;rt++){ |  | ||||||
|  |  | ||||||
|     std::vector<int> icoor(Nd); |  | ||||||
|     std::vector<SpinMatrix_s> extracted(Nsimd);                |  | ||||||
|  |  | ||||||
|     for(int i=0;i<Lblock;i++){ |  | ||||||
|     for(int j=0;j<Rblock;j++){ |  | ||||||
|     for(int m=0;m<Nmom;m++){ |  | ||||||
|  |  | ||||||
|       int ij_rdx = m+Nmom*i+Nmom*Lblock*j+Nmom*Lblock*Rblock*rt; |  | ||||||
|  |  | ||||||
|       extract(lvSum[ij_rdx],extracted); |  | ||||||
|  |  | ||||||
|       for(int idx=0;idx<Nsimd;idx++){ |  | ||||||
|  |  | ||||||
| 	grid->iCoorFromIindex(icoor,idx); |  | ||||||
|  |  | ||||||
| 	int ldx    = rt+icoor[orthogdim]*rd; |  | ||||||
|  |  | ||||||
| 	int ij_ldx = m+Nmom*i+Nmom*Lblock*j+Nmom*Lblock*Rblock*ldx; |  | ||||||
|  |  | ||||||
| 	lsSum[ij_ldx]=lsSum[ij_ldx]+extracted[idx]; |  | ||||||
|  |  | ||||||
|       } |  | ||||||
|     }}} |  | ||||||
|   } |  | ||||||
|   t1+=usecond(); |  | ||||||
|  |  | ||||||
|   assert(mat.dimension(0) == Nmom); |  | ||||||
|   assert(mat.dimension(1) == Ngamma); |  | ||||||
|   assert(mat.dimension(2) == Nt); |  | ||||||
|   t2-=usecond(); |  | ||||||
|   // ld loop and local only?? |  | ||||||
|   int pd = grid->_processors[orthogdim]; |  | ||||||
|   int pc = grid->_processor_coor[orthogdim]; |  | ||||||
|   parallel_for_nest2(int lt=0;lt<ld;lt++) |  | ||||||
|   { |  | ||||||
|     for(int pt=0;pt<pd;pt++){ |  | ||||||
|       int t = lt + pt*ld; |  | ||||||
|       if (pt == pc){ |  | ||||||
| 	for(int i=0;i<Lblock;i++){ |  | ||||||
| 	  for(int j=0;j<Rblock;j++){ |  | ||||||
| 	    for(int m=0;m<Nmom;m++){ |  | ||||||
| 	      int ij_dx = m+Nmom*i + Nmom*Lblock * j + Nmom*Lblock * Rblock * lt; |  | ||||||
| 	      for(int mu=0;mu<Ngamma;mu++){ |  | ||||||
| 		// this is a bit slow |  | ||||||
| 		mat(m,mu,t,i,j) = trace(lsSum[ij_dx]*Gamma(gammas[mu])); |  | ||||||
| 	      } |  | ||||||
| 	    } |  | ||||||
| 	  } |  | ||||||
| 	} |  | ||||||
|       } else {  |  | ||||||
| 	const scalar_type zz(0.0); |  | ||||||
| 	for(int i=0;i<Lblock;i++){ |  | ||||||
| 	  for(int j=0;j<Rblock;j++){ |  | ||||||
| 	    for(int mu=0;mu<Ngamma;mu++){ |  | ||||||
| 	      for(int m=0;m<Nmom;m++){ |  | ||||||
| 		mat(m,mu,t,i,j) =zz; |  | ||||||
| 	      } |  | ||||||
| 	    } |  | ||||||
| 	  } |  | ||||||
| 	} |  | ||||||
|       } |  | ||||||
|     } |  | ||||||
|   } |  | ||||||
|   t2+=usecond(); |  | ||||||
|   //////////////////////////////////////////////////////////////////// |  | ||||||
|   // This global sum is taking as much as 50% of time on 16 nodes |  | ||||||
|   // Vector size is 7 x 16 x 32 x 16 x 16 x sizeof(complex) = 2MB - 60MB depending on volume |  | ||||||
|   // Healthy size that should suffice |  | ||||||
|   //////////////////////////////////////////////////////////////////// |  | ||||||
|   t3-=usecond(); |  | ||||||
|   grid->GlobalSumVector(&mat(0,0,0,0,0),Nmom*Ngamma*Nt*Lblock*Rblock); |  | ||||||
|   t3+=usecond(); |  | ||||||
| } |  | ||||||
|  |  | ||||||
| // execution /////////////////////////////////////////////////////////////////// | // execution /////////////////////////////////////////////////////////////////// | ||||||
| template <typename FImpl> | template <typename FImpl> | ||||||
| void TA2AMesonField<FImpl>::execute(void) | void TA2AMesonField<FImpl>::execute(void) | ||||||
| @@ -412,8 +218,9 @@ void TA2AMesonField<FImpl>::execute(void) | |||||||
| 	Eigen::Tensor<ComplexD,5> mesonFieldBlocked(nmom,ngamma,nt,N_iii,N_jjj);     | 	Eigen::Tensor<ComplexD,5> mesonFieldBlocked(nmom,ngamma,nt,N_iii,N_jjj);     | ||||||
|  |  | ||||||
| 	t_contr-=usecond(); | 	t_contr-=usecond(); | ||||||
| 	MesonField(mesonFieldBlocked, &w[ii], &v[jj], gammas, phases,Tp, | 	A2Autils<FImpl>::MesonField(mesonFieldBlocked,  | ||||||
| 		   t_int_0,t_int_1,t_int_2,t_int_3); | 				    &w[ii],  | ||||||
|  | 				    &v[jj], gammas, phases,Tp); | ||||||
| 	t_contr+=usecond(); | 	t_contr+=usecond(); | ||||||
| 	flops += vol * ( 2 * 8.0 + 6.0 + 8.0*nmom) * N_iii*N_jjj*ngamma; | 	flops += vol * ( 2 * 8.0 + 6.0 + 8.0*nmom) * N_iii*N_jjj*ngamma; | ||||||
|  |  | ||||||
| @@ -441,14 +248,6 @@ void TA2AMesonField<FImpl>::execute(void) | |||||||
|     LOG(Message) << " Contraction of MesonFields took "<<(t1-t0)/1.0e6<< " seconds "  << std::endl; |     LOG(Message) << " Contraction of MesonFields took "<<(t1-t0)/1.0e6<< " seconds "  << std::endl; | ||||||
|     LOG(Message) << " Schur "<<(t_schur)/1.0e6<< " seconds "  << std::endl; |     LOG(Message) << " Schur "<<(t_schur)/1.0e6<< " seconds "  << std::endl; | ||||||
|     LOG(Message) << " Contr "<<(t_contr)/1.0e6<< " seconds "  << std::endl; |     LOG(Message) << " Contr "<<(t_contr)/1.0e6<< " seconds "  << std::endl; | ||||||
|     LOG(Message) << " Intern0 "<<(t_int_0)/1.0e6<< " seconds "  << std::endl; |  | ||||||
|     LOG(Message) << " Intern1 "<<(t_int_1)/1.0e6<< " seconds "  << std::endl; |  | ||||||
|     LOG(Message) << " Intern2 "<<(t_int_2)/1.0e6<< " seconds "  << std::endl; |  | ||||||
|     LOG(Message) << " Intern3 "<<(t_int_3)/1.0e6<< " seconds "  << std::endl; |  | ||||||
|  |  | ||||||
|     double t_kernel = t_int_0 + t_int_1; |  | ||||||
|     LOG(Message) << " Arith "<<flops/(t_kernel)/1.0e3/nodes<< " Gflop/s / node "  << std::endl; |  | ||||||
|     LOG(Message) << " Arith "<<bytes/(t_kernel)/1.0e3/nodes<< " GB/s /node "  << std::endl; |  | ||||||
|  |  | ||||||
|     ///////////////////////////////////////////////////////////////////////// |     ///////////////////////////////////////////////////////////////////////// | ||||||
|     // Test: Build the pion correlator (two end) |     // Test: Build the pion correlator (two end) | ||||||
|   | |||||||
							
								
								
									
										8
									
								
								extras/Hadrons/Modules/MContraction/A2APionField.cc
									
									
									
									
									
										Normal file
									
								
							
							
						
						
									
										8
									
								
								extras/Hadrons/Modules/MContraction/A2APionField.cc
									
									
									
									
									
										Normal file
									
								
							| @@ -0,0 +1,8 @@ | |||||||
|  | #include <Grid/Hadrons/Modules/MContraction/A2APionField.hpp> | ||||||
|  |  | ||||||
|  | using namespace Grid; | ||||||
|  | using namespace Hadrons; | ||||||
|  | using namespace MContraction; | ||||||
|  |  | ||||||
|  | template class Grid::Hadrons::MContraction::TA2APionField<FIMPL>; | ||||||
|  | template class Grid::Hadrons::MContraction::TA2APionField<ZFIMPL>; | ||||||
							
								
								
									
										502
									
								
								extras/Hadrons/Modules/MContraction/A2APionField.hpp
									
									
									
									
									
										Normal file
									
								
							
							
						
						
									
										502
									
								
								extras/Hadrons/Modules/MContraction/A2APionField.hpp
									
									
									
									
									
										Normal file
									
								
							| @@ -0,0 +1,502 @@ | |||||||
|  | #ifndef Hadrons_MContraction_A2APionField_hpp_ | ||||||
|  | #define Hadrons_MContraction_A2APionField_hpp_ | ||||||
|  |  | ||||||
|  | #include <Grid/Hadrons/Global.hpp> | ||||||
|  | #include <Grid/Hadrons/Module.hpp> | ||||||
|  | #include <Grid/Hadrons/ModuleFactory.hpp> | ||||||
|  | #include <Grid/Hadrons/AllToAllVectors.hpp> | ||||||
|  | #include <Grid/Hadrons/Modules/MContraction/A2Autils.hpp> | ||||||
|  |  | ||||||
|  | BEGIN_HADRONS_NAMESPACE | ||||||
|  |  | ||||||
|  | /****************************************************************************** | ||||||
|  |  *                         A2APionField                                       * | ||||||
|  |  ******************************************************************************/ | ||||||
|  | BEGIN_MODULE_NAMESPACE(MContraction) | ||||||
|  |  | ||||||
|  | typedef std::pair<Gamma::Algebra, Gamma::Algebra> GammaPair; | ||||||
|  |  | ||||||
|  |  | ||||||
|  | class A2APionFieldPar : Serializable | ||||||
|  | { | ||||||
|  |   public: | ||||||
|  |     GRID_SERIALIZABLE_CLASS_MEMBERS(A2APionFieldPar, | ||||||
|  | 				    int, cacheBlock, | ||||||
|  | 				    int, schurBlock, | ||||||
|  | 				    int, Nmom, | ||||||
|  |                                     std::string, A2A_i, | ||||||
|  |                                     std::string, A2A_j, | ||||||
|  |                                     std::string, output); | ||||||
|  | }; | ||||||
|  |  | ||||||
|  | template <typename FImpl> | ||||||
|  | class TA2APionField : public Module<A2APionFieldPar> | ||||||
|  | { | ||||||
|  | public: | ||||||
|  |   FERM_TYPE_ALIASES(FImpl, ); | ||||||
|  |   SOLVER_TYPE_ALIASES(FImpl, ); | ||||||
|  |  | ||||||
|  |   typedef typename FImpl::SiteSpinor vobj; | ||||||
|  |  | ||||||
|  |   typedef typename vobj::scalar_object sobj; | ||||||
|  |   typedef typename vobj::scalar_type scalar_type; | ||||||
|  |   typedef typename vobj::vector_type vector_type; | ||||||
|  |    | ||||||
|  |   typedef iSpinMatrix<vector_type> SpinMatrix_v; | ||||||
|  |   typedef iSpinMatrix<scalar_type> SpinMatrix_s; | ||||||
|  |   typedef iSinglet<vector_type> Scalar_v; | ||||||
|  |   typedef iSinglet<scalar_type> Scalar_s; | ||||||
|  |  | ||||||
|  |   typedef A2AModesSchurDiagTwo<typename FImpl::FermionField, FMat, Solver> A2ABase; | ||||||
|  |  | ||||||
|  |   public: | ||||||
|  |     // constructor | ||||||
|  |     TA2APionField(const std::string name); | ||||||
|  |     // destructor | ||||||
|  |     virtual ~TA2APionField(void){}; | ||||||
|  |     // dependency relation | ||||||
|  |     virtual std::vector<std::string> getInput(void); | ||||||
|  |     virtual std::vector<std::string> getOutput(void); | ||||||
|  |     // setup | ||||||
|  |     virtual void setup(void); | ||||||
|  |     // execution | ||||||
|  |     virtual void execute(void); | ||||||
|  |  | ||||||
|  | }; | ||||||
|  |  | ||||||
|  | MODULE_REGISTER(A2APionField, ARG(TA2APionField<FIMPL>), MContraction); | ||||||
|  | MODULE_REGISTER(ZA2APionField, ARG(TA2APionField<ZFIMPL>), MContraction); | ||||||
|  |  | ||||||
|  | /****************************************************************************** | ||||||
|  | *                  TA2APionField implementation                             * | ||||||
|  | ******************************************************************************/ | ||||||
|  | // constructor ///////////////////////////////////////////////////////////////// | ||||||
|  | template <typename FImpl> | ||||||
|  | TA2APionField<FImpl>::TA2APionField(const std::string name) | ||||||
|  |     : Module<A2APionFieldPar>(name) | ||||||
|  | { | ||||||
|  | } | ||||||
|  |  | ||||||
|  | // dependencies/products /////////////////////////////////////////////////////// | ||||||
|  | template <typename FImpl> | ||||||
|  | std::vector<std::string> TA2APionField<FImpl>::getInput(void) | ||||||
|  | { | ||||||
|  |   std::vector<std::string> in; | ||||||
|  |   in.push_back(par().A2A_i + "_class"); | ||||||
|  |   in.push_back(par().A2A_i + "_w_high_4d"); | ||||||
|  |   in.push_back(par().A2A_i + "_v_high_4d"); | ||||||
|  |   in.push_back(par().A2A_j + "_class"); | ||||||
|  |   in.push_back(par().A2A_j + "_w_high_4d"); | ||||||
|  |   in.push_back(par().A2A_j + "_v_high_4d"); | ||||||
|  |    | ||||||
|  |   return in; | ||||||
|  | } | ||||||
|  |  | ||||||
|  | template <typename FImpl> | ||||||
|  | std::vector<std::string> TA2APionField<FImpl>::getOutput(void) | ||||||
|  | { | ||||||
|  |     std::vector<std::string> out = {}; | ||||||
|  |  | ||||||
|  |     return out; | ||||||
|  | } | ||||||
|  |  | ||||||
|  |  | ||||||
|  | // setup /////////////////////////////////////////////////////////////////////// | ||||||
|  | template <typename FImpl> | ||||||
|  | void TA2APionField<FImpl>::setup(void) | ||||||
|  | { | ||||||
|  |  | ||||||
|  |   // Four D fields | ||||||
|  |   envTmp(std::vector<FermionField>, "wi", 1, par().schurBlock, FermionField(env().getGrid(1))); | ||||||
|  |   envTmp(std::vector<FermionField>, "vi", 1, par().schurBlock, FermionField(env().getGrid(1))); | ||||||
|  |   envTmp(std::vector<FermionField>, "wj", 1, par().schurBlock, FermionField(env().getGrid(1))); | ||||||
|  |   envTmp(std::vector<FermionField>, "vj", 1, par().schurBlock, FermionField(env().getGrid(1))); | ||||||
|  |  | ||||||
|  |   // 5D tmp | ||||||
|  |   int Ls_i = env().getObjectLs(par().A2A_i + "_class"); | ||||||
|  |   envTmpLat(FermionField, "tmp_5d", Ls_i); | ||||||
|  |    | ||||||
|  |   int Ls_j= env().getObjectLs(par().A2A_j + "_class"); | ||||||
|  |   assert ( Ls_i == Ls_j );  | ||||||
|  | } | ||||||
|  |  | ||||||
|  | // execution /////////////////////////////////////////////////////////////////// | ||||||
|  | template <typename FImpl> | ||||||
|  | void TA2APionField<FImpl>::execute(void) | ||||||
|  | { | ||||||
|  |     LOG(Message) << "Computing A2A Pion fields" << std::endl; | ||||||
|  |  | ||||||
|  |     auto &a2a_i = envGet(A2ABase, par().A2A_i + "_class"); | ||||||
|  |     auto &a2a_j = envGet(A2ABase, par().A2A_j + "_class"); | ||||||
|  |  | ||||||
|  |     /////////////////////////////////////////////// | ||||||
|  |     // Square assumption for now Nl = Nr = N | ||||||
|  |     /////////////////////////////////////////////// | ||||||
|  |     int nt = env().getDim(Tp); | ||||||
|  |     int nx = env().getDim(Xp); | ||||||
|  |     int ny = env().getDim(Yp); | ||||||
|  |     int nz = env().getDim(Zp); | ||||||
|  |  | ||||||
|  |     //    int N_i  = a2a_i.par().N; | ||||||
|  |     //    int N_j  = a2a_j.par().N; | ||||||
|  |     int N_i  = a2a_i.getN(); | ||||||
|  |     int N_j  = a2a_j.getN(); | ||||||
|  |  | ||||||
|  |     int nmom=par().Nmom; | ||||||
|  |  | ||||||
|  |     int schurBlock = par().schurBlock; | ||||||
|  |     int cacheBlock = par().cacheBlock; | ||||||
|  |  | ||||||
|  |  | ||||||
|  |     /////////////////////////////////////////////// | ||||||
|  |     // Momentum setup | ||||||
|  |     /////////////////////////////////////////////// | ||||||
|  |     GridBase *grid = env().getGrid(1); | ||||||
|  |     std::vector<LatticeComplex> phases(nmom,grid); | ||||||
|  |     for(int m=0;m<nmom;m++){ | ||||||
|  |       phases[m] = Complex(1.0);    // All zero momentum for now | ||||||
|  |     } | ||||||
|  |  | ||||||
|  |     /////////////////////////////////////////////////////////////////////// | ||||||
|  |     // i and j represent different flavours, hits, with different ranks. | ||||||
|  |     // in general non-square case. | ||||||
|  |     /////////////////////////////////////////////////////////////////////// | ||||||
|  |     Eigen::Tensor<ComplexD,4> pionFieldWVmom_ij     (nmom,nt,N_i,N_j);     | ||||||
|  |     Eigen::Tensor<ComplexD,3> pionFieldWV_ij        (nt,N_i,N_j);     | ||||||
|  |  | ||||||
|  |     Eigen::Tensor<ComplexD,4> pionFieldWVmom_ji     (nmom,nt,N_j,N_i);     | ||||||
|  |     Eigen::Tensor<ComplexD,3> pionFieldWV_ji        (nt,N_j,N_i);     | ||||||
|  |  | ||||||
|  |  | ||||||
|  |     LOG(Message) << "Rank for A2A PionField is " << N_i << " x "<<N_j << std::endl; | ||||||
|  |  | ||||||
|  |     envGetTmp(std::vector<FermionField>, wi); | ||||||
|  |     envGetTmp(std::vector<FermionField>, vi); | ||||||
|  |  | ||||||
|  |     envGetTmp(std::vector<FermionField>, wj); | ||||||
|  |     envGetTmp(std::vector<FermionField>, vj); | ||||||
|  |     envGetTmp(FermionField, tmp_5d); | ||||||
|  |  | ||||||
|  |     LOG(Message) << "Finding v and w vectors " << std::endl; | ||||||
|  |  | ||||||
|  |     ////////////////////////////////////////////////////////////////////////// | ||||||
|  |     // i,j   is first  loop over SchurBlock factors reusing 5D matrices | ||||||
|  |     // ii,jj is second loop over cacheBlock factors for high perf contractoin | ||||||
|  |     // iii,jjj are loops within cacheBlock | ||||||
|  |     // Total index is sum of these  i+ii+iii etc... | ||||||
|  |     ////////////////////////////////////////////////////////////////////////// | ||||||
|  |      | ||||||
|  |     double flops = 0.0; | ||||||
|  |     double bytes = 0.0; | ||||||
|  |     double vol   = nx*ny*nz*nt; | ||||||
|  |     double vol3  = nx*ny*nz; | ||||||
|  |     double t_schur=0; | ||||||
|  |     double t_contr_vwm=0; | ||||||
|  |     double t_contr_vw=0; | ||||||
|  |     double t_contr_ww=0; | ||||||
|  |     double t_contr_vv=0; | ||||||
|  |  | ||||||
|  |     double tt0 = usecond(); | ||||||
|  |     for(int i=0;i<N_i;i+=schurBlock){ //loop over SchurBlocking to suppress 5D matrix overhead | ||||||
|  |     for(int j=0;j<N_j;j+=schurBlock){ | ||||||
|  |  | ||||||
|  |       /////////////////////////////////////////////////////////////// | ||||||
|  |       // Get the W and V vectors for this schurBlock^2 set of terms | ||||||
|  |       /////////////////////////////////////////////////////////////// | ||||||
|  |       int N_ii = MIN(N_i-i,schurBlock); | ||||||
|  |       int N_jj = MIN(N_j-j,schurBlock); | ||||||
|  |  | ||||||
|  |       t_schur-=usecond(); | ||||||
|  |       for(int ii =0;ii < N_ii;ii++) a2a_i.return_w(i+ii, tmp_5d, wi[ii]); | ||||||
|  |       for(int jj =0;jj < N_jj;jj++) a2a_j.return_w(j+jj, tmp_5d, wj[jj]); | ||||||
|  |  | ||||||
|  |       for(int ii =0;ii < N_ii;ii++) a2a_i.return_v(i+ii, tmp_5d, vi[ii]); | ||||||
|  |       for(int jj =0;jj < N_jj;jj++) a2a_j.return_v(j+jj, tmp_5d, vj[jj]); | ||||||
|  |       t_schur+=usecond(); | ||||||
|  |  | ||||||
|  |       LOG(Message) << "Found i w&v vectors " << i <<" .. " << i+N_ii-1 << std::endl; | ||||||
|  |       LOG(Message) << "Found j w&v vectors " << j <<" .. " << j+N_jj-1 << std::endl; | ||||||
|  |  | ||||||
|  |       /////////////////////////////////////////////////////////////// | ||||||
|  |       // Series of cache blocked chunks of the contractions within this SchurBlock | ||||||
|  |       ///////////////////////////////////////////////////////////////  | ||||||
|  |       for(int ii=0;ii<N_ii;ii+=cacheBlock){ | ||||||
|  |       for(int jj=0;jj<N_jj;jj+=cacheBlock){ | ||||||
|  |  | ||||||
|  | 	int N_iii = MIN(N_ii-ii,cacheBlock); | ||||||
|  | 	int N_jjj = MIN(N_jj-jj,cacheBlock); | ||||||
|  |  | ||||||
|  | 	Eigen::Tensor<ComplexD,4> pionFieldWVmomB_ij(nmom,nt,N_iii,N_jjj);     | ||||||
|  | 	Eigen::Tensor<ComplexD,4> pionFieldWVmomB_ji(nmom,nt,N_jjj,N_iii);     | ||||||
|  |  | ||||||
|  | 	Eigen::Tensor<ComplexD,3> pionFieldWVB_ij(nt,N_iii,N_jjj);     | ||||||
|  | 	Eigen::Tensor<ComplexD,3> pionFieldWVB_ji(nt,N_jjj,N_iii);     | ||||||
|  |  | ||||||
|  | 	t_contr_vwm-=usecond(); | ||||||
|  | 	A2Autils<FImpl>::PionFieldWVmom(pionFieldWVmomB_ij, &wi[ii], &vj[jj], phases,Tp); | ||||||
|  | 	A2Autils<FImpl>::PionFieldWVmom(pionFieldWVmomB_ji, &wj[jj], &vi[ii], phases,Tp); | ||||||
|  | 	t_contr_vwm+=usecond(); | ||||||
|  |  | ||||||
|  | 	t_contr_vw-=usecond(); | ||||||
|  | 	A2Autils<FImpl>::PionFieldWV(pionFieldWVB_ij, &wi[ii], &vj[jj],Tp); | ||||||
|  | 	A2Autils<FImpl>::PionFieldWV(pionFieldWVB_ji, &wj[jj], &vi[ii],Tp); | ||||||
|  | 	t_contr_vw+=usecond(); | ||||||
|  |  | ||||||
|  |  | ||||||
|  | 	flops += vol * ( 2 * 8.0 + 6.0 + 8.0*nmom) * N_iii*N_jjj; | ||||||
|  |  | ||||||
|  | 	bytes  += vol * (12.0 * sizeof(Complex) ) * N_iii*N_jjj | ||||||
|  | 	       +  vol * ( 2.0 * sizeof(Complex) *nmom ) * N_iii*N_jjj; | ||||||
|  |  | ||||||
|  | 	/////////////////////////////////////////////////////////////// | ||||||
|  | 	// Copy back to full meson field tensor | ||||||
|  | 	///////////////////////////////////////////////////////////////  | ||||||
|  | 	parallel_for_nest2(int iii=0;iii< N_iii;iii++) { | ||||||
|  |         for(int jjj=0;jjj< N_jjj;jjj++) { | ||||||
|  |  | ||||||
|  | 	  for(int m =0;m< nmom;m++) { | ||||||
|  |           for(int t =0;t< nt;t++) { | ||||||
|  | 	    pionFieldWVmom_ij(m,t,i+ii+iii,j+jj+jjj) = pionFieldWVmomB_ij(m,t,iii,jjj); | ||||||
|  | 	    pionFieldWVmom_ji(m,t,j+jj+jjj,i+ii+iii) = pionFieldWVmomB_ji(m,t,jjj,iii); | ||||||
|  | 	  }} | ||||||
|  |  | ||||||
|  |           for(int t =0;t< nt;t++) { | ||||||
|  | 	    pionFieldWV_ij(t,i+ii+iii,j+jj+jjj) = pionFieldWVB_ij(t,iii,jjj); | ||||||
|  | 	    pionFieldWV_ji(t,j+jj+jjj,i+ii+iii) = pionFieldWVB_ji(t,jjj,iii); | ||||||
|  | 	  } | ||||||
|  |  | ||||||
|  | 	}} | ||||||
|  |       }} | ||||||
|  |     }} | ||||||
|  |  | ||||||
|  |     double nodes=grid->NodeCount(); | ||||||
|  |     double tt1 = usecond(); | ||||||
|  |     LOG(Message) << " Contraction of PionFields took "<<(tt1-tt0)/1.0e6<< " seconds "  << std::endl; | ||||||
|  |     LOG(Message) << " Schur "<<(t_schur)/1.0e6<< " seconds "  << std::endl; | ||||||
|  |     LOG(Message) << " Contr WVmom "<<(t_contr_vwm)/1.0e6<< " seconds "  << std::endl; | ||||||
|  |     LOG(Message) << " Contr WV    "<<(t_contr_vw)/1.0e6<< " seconds "  << std::endl; | ||||||
|  |  | ||||||
|  |     double t_kernel = t_contr_vwm; | ||||||
|  |     LOG(Message) << " Arith "<<flops/(t_kernel)/1.0e3/nodes<< " Gflop/s / node "  << std::endl; | ||||||
|  |     LOG(Message) << " Arith "<<bytes/(t_kernel)/1.0e3/nodes<< " GB/s /node "  << std::endl; | ||||||
|  |  | ||||||
|  |     ///////////////////////////////////////////////////////////////////////// | ||||||
|  |     // Test: Build the pion correlator (two end) | ||||||
|  |     // < PI_ij(t0) PI_ji (t0+t) > | ||||||
|  |     ///////////////////////////////////////////////////////////////////////// | ||||||
|  |     std::vector<ComplexD> corrMom(nt,ComplexD(0.0)); | ||||||
|  |  | ||||||
|  |     for(int i=0;i<N_i;i++){ | ||||||
|  |     for(int j=0;j<N_j;j++){ | ||||||
|  |       int m=0; // first momentum | ||||||
|  |       for(int t0=0;t0<nt;t0++){ | ||||||
|  |       for(int t=0;t<nt;t++){ | ||||||
|  | 	int tt = (t0+t)%nt; | ||||||
|  | 	corrMom[t] += pionFieldWVmom_ij(m,t0,i,j)* pionFieldWVmom_ji(m,tt,j,i); | ||||||
|  |       }} | ||||||
|  |     }}     | ||||||
|  |     for(int t=0;t<nt;t++) corrMom[t] = corrMom[t]/ (double)nt; | ||||||
|  |  | ||||||
|  |     for(int t=0;t<nt;t++) LOG(Message) << " C_vwm " << t << " " << corrMom[t]<<std::endl; | ||||||
|  |  | ||||||
|  |  | ||||||
|  |     ///////////////////////////////////////////////////////////////////////// | ||||||
|  |     // Test: Build the pion correlator (two end) from zero mom contraction | ||||||
|  |     // < PI_ij(t0) PI_ji (t0+t) > | ||||||
|  |     ///////////////////////////////////////////////////////////////////////// | ||||||
|  |     std::vector<ComplexD> corr(nt,ComplexD(0.0)); | ||||||
|  |  | ||||||
|  |     for(int i=0;i<N_i;i++){ | ||||||
|  |     for(int j=0;j<N_j;j++){ | ||||||
|  |       for(int t0=0;t0<nt;t0++){ | ||||||
|  |       for(int t=0;t<nt;t++){ | ||||||
|  | 	int tt = (t0+t)%nt; | ||||||
|  | 	corr[t] += pionFieldWV_ij(t0,i,j)* pionFieldWV_ji(tt,j,i); | ||||||
|  |       }} | ||||||
|  |     }}     | ||||||
|  |     for(int t=0;t<nt;t++) corr[t] = corr[t]/ (double)nt; | ||||||
|  |  | ||||||
|  |     for(int t=0;t<nt;t++) LOG(Message) << " C_vw " << t << " " << corr[t]<<std::endl; | ||||||
|  |  | ||||||
|  |  | ||||||
|  |     ///////////////////////////////////////////////////////////////////////// | ||||||
|  |     // Test: Build the pion correlator from zero mom contraction with revers  | ||||||
|  |     // charge flow | ||||||
|  |     ///////////////////////////////////////////////////////////////////////// | ||||||
|  |     std::vector<ComplexD> corr_wwvv(nt,ComplexD(0.0)); | ||||||
|  |  | ||||||
|  |     wi.resize(N_i,grid); | ||||||
|  |     vi.resize(N_i,grid); | ||||||
|  |     wj.resize(N_j,grid); | ||||||
|  |     vj.resize(N_j,grid); | ||||||
|  |  | ||||||
|  |     for(int i =0;i < N_i;i++) a2a_i.return_v(i, tmp_5d, vi[i]); | ||||||
|  |     for(int i =0;i < N_i;i++) a2a_i.return_w(i, tmp_5d, wi[i]); | ||||||
|  |     for(int j =0;j < N_j;j++) a2a_j.return_v(j, tmp_5d, vj[j]); | ||||||
|  |     for(int j =0;j < N_j;j++) a2a_j.return_w(j, tmp_5d, wj[j]); | ||||||
|  |  | ||||||
|  |     Eigen::Tensor<ComplexD,3> pionFieldWW_ij        (nt,N_i,N_j);     | ||||||
|  |     Eigen::Tensor<ComplexD,3> pionFieldVV_ji        (nt,N_j,N_i);     | ||||||
|  |     Eigen::Tensor<ComplexD,3> pionFieldWW_ji        (nt,N_j,N_i);     | ||||||
|  |     Eigen::Tensor<ComplexD,3> pionFieldVV_ij        (nt,N_i,N_j);     | ||||||
|  |  | ||||||
|  |     A2Autils<FImpl>::PionFieldWW(pionFieldWW_ij, &wi[0], &wj[0],Tp); | ||||||
|  |     A2Autils<FImpl>::PionFieldVV(pionFieldVV_ji, &vj[0], &vi[0],Tp); | ||||||
|  |     A2Autils<FImpl>::PionFieldWW(pionFieldWW_ji, &wj[0], &wi[0],Tp); | ||||||
|  |     A2Autils<FImpl>::PionFieldVV(pionFieldVV_ij, &vi[0], &vj[0],Tp); | ||||||
|  |  | ||||||
|  |  | ||||||
|  |     for(int i=0;i<N_i;i++){ | ||||||
|  |     for(int j=0;j<N_j;j++){ | ||||||
|  |       for(int t0=0;t0<nt;t0++){ | ||||||
|  |       for(int t=0;t<nt;t++){ | ||||||
|  | 	int tt = (t0+t)%nt; | ||||||
|  | 	corr_wwvv[t] += pionFieldWW_ij(t0,i,j)* pionFieldVV_ji(tt,j,i); | ||||||
|  | 	corr_wwvv[t] += pionFieldWW_ji(t0,j,i)* pionFieldVV_ij(tt,i,j); | ||||||
|  |       }} | ||||||
|  |     }}     | ||||||
|  |     for(int t=0;t<nt;t++) corr_wwvv[t] = corr_wwvv[t] / vol /2.0 ; // (ij+ji noise contribs if i!=j ). | ||||||
|  |  | ||||||
|  |     for(int t=0;t<nt;t++) LOG(Message) << " C_wwvv " << t << " " << corr_wwvv[t]<<std::endl; | ||||||
|  |  | ||||||
|  |  | ||||||
|  |     ///////////////////////////////////////////////////////////////////////// | ||||||
|  |     // This is only correct if there are NO low modes | ||||||
|  |     // Use the "ii" case to construct possible Z wall source one end trick | ||||||
|  |     ///////////////////////////////////////////////////////////////////////// | ||||||
|  |     std::vector<ComplexD> corr_z2(nt,ComplexD(0.0)); | ||||||
|  |     Eigen::Tensor<ComplexD,3> pionFieldWW        (nt,N_i,N_i);     | ||||||
|  |     Eigen::Tensor<ComplexD,3> pionFieldVV        (nt,N_i,N_i);     | ||||||
|  |  | ||||||
|  |  | ||||||
|  |     A2Autils<FImpl>::PionFieldWW(pionFieldWW, &wi[0], &wi[0],Tp); | ||||||
|  |     A2Autils<FImpl>::PionFieldVV(pionFieldVV, &vi[0], &vi[0],Tp); | ||||||
|  |     for(int i=0;i<N_i;i++){ | ||||||
|  |       for(int t0=0;t0<nt;t0++){ | ||||||
|  |       for(int t=0;t<nt;t++){ | ||||||
|  | 	int tt = (t0+t)%nt; | ||||||
|  | 	corr_z2[t] += pionFieldWW(t0,i,i) * pionFieldVV(tt,i,i) /vol ; | ||||||
|  |       }} | ||||||
|  |     } | ||||||
|  |  | ||||||
|  |     LOG(Message) << " C_z2 WARNING only correct if Nl == 0 "<<std::endl; | ||||||
|  |     for(int t=0;t<nt;t++) LOG(Message) << " C_z2 " << t << " " << corr_z2[t]<<std::endl; | ||||||
|  |  | ||||||
|  |     ///////////////////////////////////////////////////////////////////////// | ||||||
|  |     // Test: Build a bag contraction | ||||||
|  |     ///////////////////////////////////////////////////////////////////////// | ||||||
|  |     Eigen::Tensor<ComplexD,2> DeltaF2_fig8  (nt,16); | ||||||
|  |     Eigen::Tensor<ComplexD,2> DeltaF2_trtr  (nt,16); | ||||||
|  |     Eigen::Tensor<ComplexD,1> denom0 (nt); | ||||||
|  |     Eigen::Tensor<ComplexD,1> denom1 (nt); | ||||||
|  |      | ||||||
|  |     const int dT=16; | ||||||
|  |  | ||||||
|  |     A2Autils<FImpl>::DeltaFeq2  (dT,dT,DeltaF2_fig8,DeltaF2_trtr, | ||||||
|  | 				 denom0,denom1, | ||||||
|  | 				 pionFieldWW_ij,&vi[0],&vj[0],Tp); | ||||||
|  |      | ||||||
|  |     {  | ||||||
|  |       int g=0; // O_{VV+AA} | ||||||
|  |       for(int t=0;t<nt;t++) | ||||||
|  | 	LOG(Message) << " Bag [" << t << ","<<g<<"]  "  | ||||||
|  | 		     << (DeltaF2_fig8(t,g)+DeltaF2_trtr(t,g))  | ||||||
|  | 	  /             ( 8.0/3.0 * denom0[t]*denom1[t]) | ||||||
|  | 		     <<std::endl; | ||||||
|  |     } | ||||||
|  |  | ||||||
|  |     ///////////////////////////////////////////////////////////////////////// | ||||||
|  |     // Test: Build a bag contraction the Z2 way | ||||||
|  |     // Build a wall bag comparison assuming no low modes | ||||||
|  |     ///////////////////////////////////////////////////////////////////////// | ||||||
|  |     LOG(Message) << " Bag_z2 WARNING only correct if Nl == 0 "<<std::endl; | ||||||
|  |  | ||||||
|  |     int t0=0; | ||||||
|  |     int t1=dT; | ||||||
|  |     int Nl=0; | ||||||
|  |     LatticePropagator Qd0(grid); | ||||||
|  |     LatticePropagator Qd1(grid); | ||||||
|  |     LatticePropagator Qs0(grid); | ||||||
|  |     LatticePropagator Qs1(grid); | ||||||
|  |     for(int s=0;s<4;s++){ | ||||||
|  |       for(int c=0;c<3;c++){ | ||||||
|  | 	int idx0 = Nl+t0*12+s*3+c; | ||||||
|  | 	int idx1 = Nl+t1*12+s*3+c; | ||||||
|  | 	FermToProp<FImpl>(Qd0, vi[idx0], s, c); | ||||||
|  | 	FermToProp<FImpl>(Qd1, vi[idx1], s, c); | ||||||
|  | 	FermToProp<FImpl>(Qs0, vj[idx0], s, c); | ||||||
|  | 	FermToProp<FImpl>(Qs1, vj[idx1], s, c); | ||||||
|  |       } | ||||||
|  |     } | ||||||
|  |  | ||||||
|  |     std::vector<Gamma::Algebra> gammas ( { | ||||||
|  | 	  Gamma::Algebra::GammaX, | ||||||
|  | 	  Gamma::Algebra::GammaY, | ||||||
|  | 	  Gamma::Algebra::GammaZ, | ||||||
|  | 	  Gamma::Algebra::GammaT, | ||||||
|  | 	  Gamma::Algebra::GammaXGamma5, | ||||||
|  | 	  Gamma::Algebra::GammaYGamma5, | ||||||
|  | 	  Gamma::Algebra::GammaZGamma5, | ||||||
|  | 	  Gamma::Algebra::GammaTGamma5, | ||||||
|  | 	  Gamma::Algebra::Identity,     | ||||||
|  |           Gamma::Algebra::Gamma5, | ||||||
|  | 	  Gamma::Algebra::SigmaXY, | ||||||
|  | 	  Gamma::Algebra::SigmaXZ, | ||||||
|  | 	  Gamma::Algebra::SigmaXT, | ||||||
|  | 	  Gamma::Algebra::SigmaYZ, | ||||||
|  | 	  Gamma::Algebra::SigmaYT, | ||||||
|  | 	  Gamma::Algebra::SigmaZT | ||||||
|  |     }); | ||||||
|  |  | ||||||
|  |     auto G5 = Gamma::Algebra::Gamma5; | ||||||
|  |     LatticePropagator anti_d0 =  adj( Gamma(G5) * Qd0 * Gamma(G5)); | ||||||
|  |     LatticePropagator anti_d1 =  adj( Gamma(G5) * Qd1 * Gamma(G5)); | ||||||
|  |     LatticeComplex TR1(grid); | ||||||
|  |     LatticeComplex TR2(grid); | ||||||
|  |     LatticeComplex Wick1(grid); | ||||||
|  |     LatticeComplex Wick2(grid); | ||||||
|  |  | ||||||
|  |     LatticePropagator PR1(grid); | ||||||
|  |     LatticePropagator PR2(grid); | ||||||
|  |     PR1 = Qs0 * Gamma(G5) * anti_d0; | ||||||
|  |     PR2 = Qs1 * Gamma(G5) * anti_d1; | ||||||
|  |  | ||||||
|  |     for(int g=0;g<Nd*Nd;g++){ | ||||||
|  |       auto g1 = gammas[g]; | ||||||
|  |       Gamma G1 (g1); | ||||||
|  |       TR1 = trace( PR1 * G1 ); | ||||||
|  |       TR2 = trace( PR2 * G1 ); | ||||||
|  |       Wick1 = TR1*TR2; | ||||||
|  |       Wick2 = trace( PR1* G1 * PR2 * G1 ); | ||||||
|  |        | ||||||
|  |       std::vector<TComplex>  C1; | ||||||
|  |       std::vector<TComplex>  C2; | ||||||
|  |       std::vector<TComplex>  C3; | ||||||
|  |       sliceSum(Wick1,C1, Tp); | ||||||
|  |       sliceSum(Wick2,C2, Tp); | ||||||
|  |       sliceSum(TR1  ,C3, Tp); | ||||||
|  |        | ||||||
|  |       /* | ||||||
|  |       if(g<5){ | ||||||
|  | 	for(int t=0;t<C1.size();t++){ | ||||||
|  | 	  LOG(Message) << " Wick1["<<g<<","<<t<< "] "<< C1[t]<<std::endl;  | ||||||
|  | 	} | ||||||
|  | 	for(int t=0;t<C2.size();t++){ | ||||||
|  | 	  LOG(Message) << " Wick2["<<g<<","<<t<< "] "<< C2[t]<<std::endl;  | ||||||
|  | 	} | ||||||
|  |       } | ||||||
|  |       if( (g==9) || (g==7) ){ // P and At in above ordering | ||||||
|  | 	for(int t=0;t<C3.size();t++){ | ||||||
|  | 	  LOG(Message) << " <G|P>["<<g<<","<<t<< "] "<< C3[t]<<std::endl;  | ||||||
|  | 	} | ||||||
|  |       }  | ||||||
|  |       */ | ||||||
|  |     } | ||||||
|  | } | ||||||
|  |  | ||||||
|  | END_MODULE_NAMESPACE | ||||||
|  |  | ||||||
|  | END_HADRONS_NAMESPACE | ||||||
|  |  | ||||||
|  | #endif // Hadrons_MContraction_A2APionField_hpp_ | ||||||
|  |    | ||||||
							
								
								
									
										1049
									
								
								extras/Hadrons/Modules/MContraction/A2Autils.hpp
									
									
									
									
									
										Normal file
									
								
							
							
						
						
									
										1049
									
								
								extras/Hadrons/Modules/MContraction/A2Autils.hpp
									
									
									
									
									
										Normal file
									
								
							
										
											
												File diff suppressed because it is too large
												Load Diff
											
										
									
								
							| @@ -206,9 +206,9 @@ void TA2AVectors<FImpl, nBasis>::execute(void) | |||||||
|     envGetTmp(FermionField, tmp2); |     envGetTmp(FermionField, tmp2); | ||||||
|  |  | ||||||
|     int N_count = 0; |     int N_count = 0; | ||||||
|  |     for (unsigned int T = 0; T < Nsrc; T++) | ||||||
|     for (unsigned int s = 0; s < Ns; ++s) |     for (unsigned int s = 0; s < Ns; ++s) | ||||||
|     for (unsigned int c = 0; c < Nc; ++c) |     for (unsigned int c = 0; c < Nc; ++c) | ||||||
|         for (unsigned int T = 0; T < Nsrc; T++) |  | ||||||
|         { |         { | ||||||
|             auto &prop_src = envGet(PropagatorField, sources[T]); |             auto &prop_src = envGet(PropagatorField, sources[T]); | ||||||
|             LOG(Message) << "A2A src for s = " << s << " , c = " << c << ", T = " << T << std::endl; |             LOG(Message) << "A2A src for s = " << s << " , c = " << c << ", T = " << T << std::endl; | ||||||
|   | |||||||
| @@ -48,6 +48,7 @@ modules_cc =\ | |||||||
|   Modules/MContraction/A2AMeson.cc \ |   Modules/MContraction/A2AMeson.cc \ | ||||||
|   Modules/MContraction/WeakNeutral4ptDisc.cc \ |   Modules/MContraction/WeakNeutral4ptDisc.cc \ | ||||||
|   Modules/MContraction/Gamma3pt.cc \ |   Modules/MContraction/Gamma3pt.cc \ | ||||||
|  |   Modules/MContraction/A2APionField.cc \ | ||||||
|   Modules/MAction/MobiusDWF.cc \ |   Modules/MAction/MobiusDWF.cc \ | ||||||
|   Modules/MAction/WilsonClover.cc \ |   Modules/MAction/WilsonClover.cc \ | ||||||
|   Modules/MAction/Wilson.cc \ |   Modules/MAction/Wilson.cc \ | ||||||
| @@ -102,6 +103,7 @@ modules_hpp =\ | |||||||
|   Modules/MContraction/MesonFieldGamma.hpp \ |   Modules/MContraction/MesonFieldGamma.hpp \ | ||||||
|   Modules/MContraction/WeakHamiltonianEye.hpp \ |   Modules/MContraction/WeakHamiltonianEye.hpp \ | ||||||
|   Modules/MContraction/Baryon.hpp \ |   Modules/MContraction/Baryon.hpp \ | ||||||
|  |   Modules/MContraction/A2APionField.hpp \ | ||||||
|   Modules/MContraction/Meson.hpp \ |   Modules/MContraction/Meson.hpp \ | ||||||
|   Modules/MContraction/WeakHamiltonian.hpp \ |   Modules/MContraction/WeakHamiltonian.hpp \ | ||||||
|   Modules/MContraction/WeakNeutral4ptDisc.hpp \ |   Modules/MContraction/WeakNeutral4ptDisc.hpp \ | ||||||
|   | |||||||
| @@ -1,4 +1,5 @@ | |||||||
| #pragma once | #pragma once | ||||||
|  | #define EIGEN_USE_MKL_ALL | ||||||
| #if defined __GNUC__ | #if defined __GNUC__ | ||||||
| #pragma GCC diagnostic push | #pragma GCC diagnostic push | ||||||
| #pragma GCC diagnostic ignored "-Wdeprecated-declarations" | #pragma GCC diagnostic ignored "-Wdeprecated-declarations" | ||||||
|   | |||||||
| @@ -58,12 +58,10 @@ auto outerProduct (const iScalar<l>& lhs,const iScalar<r>& rhs) -> iScalar<declt | |||||||
|    |    | ||||||
| inline ComplexF outerProduct(const ComplexF &l, const ComplexF& r) | inline ComplexF outerProduct(const ComplexF &l, const ComplexF& r) | ||||||
| { | { | ||||||
|   std::cout << "outer product taking conj "<<r<<" "<<conj(r)<<std::endl; |  | ||||||
|   return l*conj(r); |   return l*conj(r); | ||||||
| } | } | ||||||
| inline ComplexD outerProduct(const ComplexD &l, const ComplexD& r) | inline ComplexD outerProduct(const ComplexD &l, const ComplexD& r) | ||||||
| { | { | ||||||
|   std::cout << "outer product taking conj "<<r<<" "<<conj(r)<<std::endl; |  | ||||||
|   return l*conj(r); |   return l*conj(r); | ||||||
| } | } | ||||||
| inline RealF outerProduct(const RealF &l, const RealF& r) | inline RealF outerProduct(const RealF &l, const RealF& r) | ||||||
|   | |||||||
		Reference in New Issue
	
	Block a user