mirror of
				https://github.com/paboyle/Grid.git
				synced 2025-10-20 16:04:45 +01:00 
			
		
		
		
	Compare commits
	
		
			5 Commits
		
	
	
		
			3c67d626ba
			...
			feature/sy
		
	
	| Author | SHA1 | Date | |
|---|---|---|---|
|  | 229709a980 | ||
|  | 9295eeadfe | ||
|  | 36f471e333 | ||
|  | ca4eadd4ab | ||
|  | d954595922 | 
| @@ -54,11 +54,9 @@ Version.h: version-cache | ||||
| include Make.inc | ||||
| include Eigen.inc | ||||
|  | ||||
| #extra_sources+=$(ZWILS_FERMION_FILES) | ||||
| extra_sources+=$(WILS_FERMION_FILES) | ||||
| extra_sources+=$(STAG_FERMION_FILES) | ||||
| if BUILD_ZMOBIUS | ||||
|   extra_sources+=$(ZWILS_FERMION_FILES) | ||||
| endif | ||||
| if BUILD_GPARITY | ||||
|   extra_sources+=$(GP_FERMION_FILES) | ||||
| endif | ||||
|   | ||||
| @@ -7,7 +7,6 @@ | ||||
|     Copyright (C) 2015 | ||||
|  | ||||
| Author: Peter Boyle <paboyle@ph.ed.ac.uk> | ||||
| Author: Christoph Lehner <christoph@lhnr.de> | ||||
|  | ||||
|     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 | ||||
| @@ -170,23 +169,6 @@ static inline int divides(int a,int b) | ||||
| } | ||||
| void GlobalSharedMemory::GetShmDims(const Coordinate &WorldDims,Coordinate &ShmDims) | ||||
| { | ||||
|   //////////////////////////////////////////////////////////////// | ||||
|   // Allow user to configure through environment variable | ||||
|   //////////////////////////////////////////////////////////////// | ||||
|   char* str = getenv(("GRID_SHM_DIMS_" + std::to_string(ShmDims.size())).c_str()); | ||||
|   if ( str ) { | ||||
|     std::vector<int> IntShmDims; | ||||
|     GridCmdOptionIntVector(std::string(str),IntShmDims); | ||||
|     assert(IntShmDims.size() == WorldDims.size()); | ||||
|     long ShmSize = 1; | ||||
|     for (int dim=0;dim<WorldDims.size();dim++) { | ||||
|       ShmSize *= (ShmDims[dim] = IntShmDims[dim]); | ||||
|       assert(divides(ShmDims[dim],WorldDims[dim])); | ||||
|     } | ||||
|     assert(ShmSize == WorldShmSize); | ||||
|     return; | ||||
|   } | ||||
|    | ||||
|   //////////////////////////////////////////////////////////////// | ||||
|   // Powers of 2,3,5 only in prime decomposition for now | ||||
|   //////////////////////////////////////////////////////////////// | ||||
|   | ||||
| @@ -112,9 +112,7 @@ Gather_plane_extract(const Lattice<vobj> &rhs, | ||||
|   if ( cbmask ==0x3){ | ||||
| #ifdef ACCELERATOR_CSHIFT     | ||||
|     autoView(rhs_v , rhs, AcceleratorRead); | ||||
|     accelerator_for(nn,e1*e2,1,{ | ||||
| 	int n = nn%e1; | ||||
| 	int b = nn/e1; | ||||
|     accelerator_for2d(n,e1,b,e2,1,{ | ||||
| 	int o      =   n*n1; | ||||
| 	int offset = b+n*e2; | ||||
| 	 | ||||
| @@ -137,9 +135,7 @@ Gather_plane_extract(const Lattice<vobj> &rhs, | ||||
|     std::cout << " Dense packed buffer WARNING " <<std::endl; // Does this get called twice once for each cb? | ||||
| #ifdef ACCELERATOR_CSHIFT     | ||||
|     autoView(rhs_v , rhs, AcceleratorRead); | ||||
|     accelerator_for(nn,e1*e2,1,{ | ||||
| 	int n = nn%e1; | ||||
| 	int b = nn/e1; | ||||
|     accelerator_for2d(n,e1,b,e2,1,{ | ||||
|  | ||||
| 	Coordinate coor; | ||||
|  | ||||
| @@ -261,9 +257,7 @@ template<class vobj> void Scatter_plane_merge(Lattice<vobj> &rhs,ExtractPointerA | ||||
|     int _slice_block = rhs.Grid()->_slice_block[dimension]; | ||||
| #ifdef ACCELERATOR_CSHIFT     | ||||
|     autoView( rhs_v , rhs, AcceleratorWrite); | ||||
|     accelerator_for(nn,e1*e2,1,{ | ||||
| 	int n = nn%e1; | ||||
| 	int b = nn/e1; | ||||
|     accelerator_for2d(n,e1,b,e2,1,{ | ||||
| 	int o      = n*_slice_stride; | ||||
| 	int offset = b+n*_slice_block; | ||||
| 	merge(rhs_v[so+o+b],pointers,offset); | ||||
| @@ -280,7 +274,7 @@ template<class vobj> void Scatter_plane_merge(Lattice<vobj> &rhs,ExtractPointerA | ||||
|  | ||||
|     // Case of SIMD split AND checker dim cannot currently be hit, except in  | ||||
|     // Test_cshift_red_black code. | ||||
|     std::cout << "Scatter_plane merge assert(0); think this is buggy FIXME "<< std::endl;// think this is buggy FIXME | ||||
|     //    std::cout << "Scatter_plane merge assert(0); think this is buggy FIXME "<< std::endl;// think this is buggy FIXME | ||||
|     std::cout<<" Unthreaded warning -- buffer is not densely packed ??"<<std::endl; | ||||
|     assert(0); // This will fail if hit on GPU | ||||
|     autoView( rhs_v, rhs, CpuWrite); | ||||
|   | ||||
| @@ -97,20 +97,6 @@ accelerator_inline void convertType(ComplexF & out, const std::complex<float> & | ||||
|   out = in; | ||||
| } | ||||
|  | ||||
| template<typename T> | ||||
| accelerator_inline EnableIf<isGridFundamental<T>> convertType(T & out, const T & in) { | ||||
|   out = in; | ||||
| } | ||||
|  | ||||
| // This would allow for conversions between GridFundamental types, but is not strictly needed as yet | ||||
| /*template<typename T1, typename T2> | ||||
| accelerator_inline typename std::enable_if<isGridFundamental<T1>::value && isGridFundamental<T2>::value>::type | ||||
| // Or to make this very broad, conversions between anything that's not a GridTensor could be allowed | ||||
| //accelerator_inline typename std::enable_if<!isGridTensor<T1>::value && !isGridTensor<T2>::value>::type | ||||
| convertType(T1 & out, const T2 & in) { | ||||
|   out = in; | ||||
| }*/ | ||||
|  | ||||
| #ifdef GRID_SIMT | ||||
| accelerator_inline void convertType(vComplexF & out, const ComplexF & in) { | ||||
|   ((ComplexF*)&out)[acceleratorSIMTlane(vComplexF::Nsimd())] = in; | ||||
| @@ -131,18 +117,23 @@ accelerator_inline void convertType(vComplexD2 & out, const vComplexF & in) { | ||||
|   Optimization::PrecisionChange::StoD(in.v,out._internal[0].v,out._internal[1].v); | ||||
| } | ||||
|  | ||||
| template<typename T1,typename T2> | ||||
| accelerator_inline void convertType(iScalar<T1> & out, const iScalar<T2> & in) { | ||||
|   convertType(out._internal,in._internal); | ||||
| template<typename T1,typename T2,int N> | ||||
|   accelerator_inline void convertType(iMatrix<T1,N> & out, const iMatrix<T2,N> & in); | ||||
| template<typename T1,typename T2,int N> | ||||
|   accelerator_inline void convertType(iVector<T1,N> & out, const iVector<T2,N> & in); | ||||
|  | ||||
| template<typename T1,typename T2, typename std::enable_if<!isGridScalar<T1>::value, T1>::type* = nullptr> | ||||
| accelerator_inline void convertType(T1 & out, const iScalar<T2> & in) { | ||||
|   convertType(out,in._internal); | ||||
| } | ||||
|  | ||||
| template<typename T1,typename T2> | ||||
| accelerator_inline NotEnableIf<isGridScalar<T1>> convertType(T1 & out, const iScalar<T2> & in) { | ||||
| template<typename T1, typename std::enable_if<!isGridScalar<T1>::value, T1>::type* = nullptr> | ||||
| accelerator_inline void convertType(T1 & out, const iScalar<T1> & in) { | ||||
|   convertType(out,in._internal); | ||||
| } | ||||
|  | ||||
| template<typename T1,typename T2> | ||||
| accelerator_inline NotEnableIf<isGridScalar<T2>> convertType(iScalar<T1> & out, const T2 & in) { | ||||
| accelerator_inline void convertType(iScalar<T1> & out, const T2 & in) { | ||||
|   convertType(out._internal,in); | ||||
| } | ||||
|  | ||||
| @@ -159,6 +150,11 @@ accelerator_inline void convertType(iVector<T1,N> & out, const iVector<T2,N> & i | ||||
|     convertType(out._internal[i],in._internal[i]); | ||||
| } | ||||
|  | ||||
| template<typename T, typename std::enable_if<isGridFundamental<T>::value, T>::type* = nullptr> | ||||
| accelerator_inline void convertType(T & out, const T & in) { | ||||
|   out = in; | ||||
| } | ||||
|  | ||||
| template<typename T1,typename T2> | ||||
| accelerator_inline void convertType(Lattice<T1> & out, const Lattice<T2> & in) { | ||||
|   autoView( out_v , out,AcceleratorWrite); | ||||
|   | ||||
| @@ -71,8 +71,8 @@ public: | ||||
|   //  accelerator_inline const vobj & operator[](size_t i) const { return this->_odata[i]; }; | ||||
|   accelerator_inline vobj       & operator[](size_t i) const { return this->_odata[i]; }; | ||||
| #else | ||||
|   accelerator_inline const vobj & operator[](size_t i) const { return this->_odata[i]; }; | ||||
|   accelerator_inline vobj       & operator[](size_t i)       { return this->_odata[i]; }; | ||||
|   //  accelerator_inline const vobj & operator[](size_t i) const { return this->_odata[i]; }; | ||||
|   //  accelerator_inline vobj       & operator[](size_t i)       { return this->_odata[i]; }; | ||||
| #endif | ||||
|  | ||||
|   accelerator_inline uint64_t begin(void) const { return 0;}; | ||||
|   | ||||
| @@ -43,7 +43,7 @@ inline void whereWolf(Lattice<vobj> &ret,const Lattice<iobj> &predicate,Lattice< | ||||
|   conformable(iftrue,predicate); | ||||
|   conformable(iftrue,ret); | ||||
|  | ||||
|   GridBase *grid=iftrue.Grid(); | ||||
|   GridBase *grid=iftrue._grid; | ||||
|  | ||||
|   typedef typename vobj::scalar_object scalar_object; | ||||
|   typedef typename vobj::scalar_type scalar_type; | ||||
| @@ -52,23 +52,22 @@ inline void whereWolf(Lattice<vobj> &ret,const Lattice<iobj> &predicate,Lattice< | ||||
|  | ||||
|   const int Nsimd = grid->Nsimd(); | ||||
|  | ||||
|   autoView(iftrue_v,iftrue,CpuRead); | ||||
|   autoView(iffalse_v,iffalse,CpuRead); | ||||
|   autoView(predicate_v,predicate,CpuRead); | ||||
|   autoView(ret_v,ret,CpuWrite); | ||||
|   Integer NN= grid->oSites(); | ||||
|   thread_for(ss,NN,{ | ||||
|     Integer mask; | ||||
|     scalar_object trueval; | ||||
|     scalar_object falseval; | ||||
|     for(int l=0;l<Nsimd;l++){ | ||||
|       trueval =extractLane(l,iftrue_v[ss]); | ||||
|       falseval=extractLane(l,iffalse_v[ss]); | ||||
|       mask    =extractLane(l,predicate_v[ss]); | ||||
|       if (mask) falseval=trueval; | ||||
|       insertLane(l,ret_v[ss],falseval); | ||||
|   std::vector<Integer> mask(Nsimd); | ||||
|   std::vector<scalar_object> truevals (Nsimd); | ||||
|   std::vector<scalar_object> falsevals(Nsimd); | ||||
|  | ||||
|   parallel_for(int ss=0;ss<iftrue._grid->oSites(); ss++){ | ||||
|  | ||||
|     extract(iftrue._odata[ss]   ,truevals); | ||||
|     extract(iffalse._odata[ss]  ,falsevals); | ||||
|     extract<vInteger,Integer>(TensorRemove(predicate._odata[ss]),mask); | ||||
|  | ||||
|     for(int s=0;s<Nsimd;s++){ | ||||
|       if (mask[s]) falsevals[s]=truevals[s]; | ||||
|     } | ||||
|  | ||||
|     merge(ret._odata[ss],falsevals); | ||||
|   } | ||||
|   }); | ||||
| } | ||||
|  | ||||
| template<class vobj,class iobj> | ||||
| @@ -77,9 +76,9 @@ inline Lattice<vobj> whereWolf(const Lattice<iobj> &predicate,Lattice<vobj> &ift | ||||
|   conformable(iftrue,iffalse); | ||||
|   conformable(iftrue,predicate); | ||||
|  | ||||
|   Lattice<vobj> ret(iftrue.Grid()); | ||||
|   Lattice<vobj> ret(iftrue._grid); | ||||
|  | ||||
|   whereWolf(ret,predicate,iftrue,iffalse); | ||||
|   where(ret,predicate,iftrue,iffalse); | ||||
|  | ||||
|   return ret; | ||||
| } | ||||
|   | ||||
| @@ -41,7 +41,7 @@ class Action | ||||
| public: | ||||
|   bool is_smeared = false; | ||||
|   // Heatbath? | ||||
|   virtual void refresh(const GaugeField& U, GridSerialRNG &sRNG, GridParallelRNG& pRNG) = 0; // refresh pseudofermions | ||||
|   virtual void refresh(const GaugeField& U, GridParallelRNG& pRNG) = 0; // refresh pseudofermions | ||||
|   virtual RealD S(const GaugeField& U) = 0;                             // evaluate the action | ||||
|   virtual void deriv(const GaugeField& U, GaugeField& dSdU) = 0;        // evaluate the action derivative | ||||
|   virtual std::string action_name()    = 0;                             // return the action name | ||||
|   | ||||
| @@ -153,8 +153,8 @@ public: | ||||
|   typedef typename Impl::StencilImpl             StencilImpl;		\ | ||||
|   typedef typename Impl::ImplParams               ImplParams;	        \ | ||||
|   typedef typename Impl::StencilImpl::View_type  StencilView;		\ | ||||
|   typedef const typename ViewMap<FermionField>::Type      FermionFieldView;	\ | ||||
|   typedef const typename ViewMap<DoubledGaugeField>::Type DoubledGaugeFieldView; | ||||
|   typedef typename ViewMap<FermionField>::Type      FermionFieldView;	\ | ||||
|   typedef typename ViewMap<DoubledGaugeField>::Type DoubledGaugeFieldView; | ||||
|  | ||||
| #define INHERIT_IMPL_TYPES(Base)		\ | ||||
|   INHERIT_GIMPL_TYPES(Base)			\ | ||||
|   | ||||
| @@ -88,7 +88,7 @@ public: | ||||
| 					  const _Spinor &chi,  | ||||
| 					  int mu,  | ||||
| 					  StencilEntry *SE, | ||||
| 					  StencilView &St)  | ||||
| 					  const StencilView &St)  | ||||
|   { | ||||
|     int direction = St._directions[mu]; | ||||
|     int distance  = St._distances[mu]; | ||||
|   | ||||
| @@ -56,8 +56,12 @@ template<class Impl> class StaggeredKernels : public FermionOperator<Impl> , pub | ||||
| 		 DoubledGaugeField &U, | ||||
| 		 const FermionField &in, FermionField &out, int dag, int interior,int exterior); | ||||
|    | ||||
|   void DhopDirKernel(StencilImpl &st, DoubledGaugeFieldView &U, DoubledGaugeFieldView &UUU, SiteSpinor * buf, | ||||
| 		     int sF, int sU, const FermionFieldView &in, FermionFieldView &out, int dir,int disp); | ||||
|   void DhopDirKernel(StencilImpl &st, | ||||
| 		     const DoubledGaugeFieldView &U, | ||||
| 		     const DoubledGaugeFieldView &UUU, SiteSpinor * buf, | ||||
| 		     int sF, int sU, | ||||
| 		     const FermionFieldView &in, | ||||
| 		     const FermionFieldView &out, int dir,int disp); | ||||
|  protected:     | ||||
|  | ||||
|    /////////////////////////////////////////////////////////////////////////////////////// | ||||
| @@ -65,53 +69,67 @@ template<class Impl> class StaggeredKernels : public FermionOperator<Impl> , pub | ||||
|    /////////////////////////////////////////////////////////////////////////////////////// | ||||
|    template<int Naik>  | ||||
|    static accelerator_inline | ||||
|    void DhopSiteGeneric(StencilView &st,  | ||||
| 			DoubledGaugeFieldView &U, DoubledGaugeFieldView &UUU,  | ||||
|    void DhopSiteGeneric(const StencilView &st,  | ||||
| 			const DoubledGaugeFieldView &U, | ||||
| 			const DoubledGaugeFieldView &UUU,  | ||||
| 			SiteSpinor * buf, int LLs, int sU,  | ||||
| 			const FermionFieldView &in, FermionFieldView &out,int dag); | ||||
| 			const FermionFieldView &in, | ||||
| 			const FermionFieldView &out,int dag); | ||||
|     | ||||
|    template<int Naik> static accelerator_inline | ||||
|    void DhopSiteGenericInt(StencilView &st,  | ||||
| 			   DoubledGaugeFieldView &U, DoubledGaugeFieldView &UUU,  | ||||
|    void DhopSiteGenericInt(const StencilView &st,  | ||||
| 			   const DoubledGaugeFieldView &U, | ||||
| 			   const DoubledGaugeFieldView &UUU,  | ||||
| 			   SiteSpinor * buf, int LLs, int sU,  | ||||
| 			   const FermionFieldView &in, FermionFieldView &out,int dag); | ||||
| 			   const FermionFieldView &in, | ||||
| 			   const FermionFieldView &out,int dag); | ||||
|     | ||||
|    template<int Naik> static accelerator_inline | ||||
|    void DhopSiteGenericExt(StencilView &st,  | ||||
| 			   DoubledGaugeFieldView &U, DoubledGaugeFieldView &UUU, | ||||
|    void DhopSiteGenericExt(const StencilView &st,  | ||||
| 			   const DoubledGaugeFieldView &U, | ||||
| 			   const DoubledGaugeFieldView &UUU, | ||||
|  			   SiteSpinor * buf, int LLs, int sU,  | ||||
| 			   const FermionFieldView &in, FermionFieldView &out,int dag); | ||||
| 			   const FermionFieldView &in, | ||||
| 			   const FermionFieldView &out,int dag); | ||||
|  | ||||
|    /////////////////////////////////////////////////////////////////////////////////////// | ||||
|    // Nc=3 specific kernels | ||||
|    /////////////////////////////////////////////////////////////////////////////////////// | ||||
|     | ||||
|    template<int Naik> static accelerator_inline | ||||
|    void DhopSiteHand(StencilView &st,  | ||||
| 		     DoubledGaugeFieldView &U,DoubledGaugeFieldView &UUU,  | ||||
|    void DhopSiteHand(const StencilView &st,  | ||||
| 		     const DoubledGaugeFieldView &U, | ||||
| 		     const DoubledGaugeFieldView &UUU,  | ||||
|  		     SiteSpinor * buf, int LLs, int sU,  | ||||
| 		     const FermionFieldView &in, FermionFieldView &out,int dag); | ||||
| 		     const FermionFieldView &in, | ||||
| 		     const FermionFieldView &out,int dag); | ||||
|     | ||||
|    template<int Naik> static accelerator_inline | ||||
|    void DhopSiteHandInt(StencilView &st,  | ||||
| 			DoubledGaugeFieldView &U,DoubledGaugeFieldView &UUU,  | ||||
|    void DhopSiteHandInt(const StencilView &st,  | ||||
| 			const DoubledGaugeFieldView &U, | ||||
| 			const DoubledGaugeFieldView &UUU,  | ||||
|  			SiteSpinor * buf, int LLs, int sU,  | ||||
| 			const FermionFieldView &in, FermionFieldView &out,int dag); | ||||
| 			const FermionFieldView &in, | ||||
| 			const FermionFieldView &out,int dag); | ||||
|     | ||||
|    template<int Naik> static accelerator_inline | ||||
|    void DhopSiteHandExt(StencilView &st,  | ||||
| 			DoubledGaugeFieldView &U,DoubledGaugeFieldView &UUU,  | ||||
|    void DhopSiteHandExt(const StencilView &st,  | ||||
| 			const DoubledGaugeFieldView &U, | ||||
| 			const DoubledGaugeFieldView &UUU,  | ||||
|  			SiteSpinor * buf, int LLs, int sU,  | ||||
| 			const FermionFieldView &in, FermionFieldView &out,int dag); | ||||
| 			const FermionFieldView &in, | ||||
| 			const FermionFieldView &out,int dag); | ||||
|  | ||||
|    /////////////////////////////////////////////////////////////////////////////////////// | ||||
|    // Asm Nc=3 specific kernels | ||||
|    /////////////////////////////////////////////////////////////////////////////////////// | ||||
|     | ||||
|    void DhopSiteAsm(StencilView &st,  | ||||
| 		    DoubledGaugeFieldView &U,DoubledGaugeFieldView &UUU,  | ||||
|    void DhopSiteAsm(const StencilView &st,  | ||||
| 		    const DoubledGaugeFieldView &U, | ||||
| 		    const DoubledGaugeFieldView &UUU,  | ||||
|  		    SiteSpinor * buf, int LLs, int sU,  | ||||
| 		    const FermionFieldView &in, FermionFieldView &out,int dag); | ||||
| 		    const FermionFieldView &in, | ||||
| 		    const FermionFieldView &out,int dag); | ||||
|    | ||||
| public: | ||||
|  | ||||
|   | ||||
| @@ -245,7 +245,7 @@ public: | ||||
|     return out; | ||||
|   } | ||||
|  | ||||
| protected: | ||||
| private: | ||||
|   // here fixing the 4 dimensions, make it more general? | ||||
|  | ||||
|   RealD csw_r;                                               // Clover coefficient - spatial | ||||
|   | ||||
| @@ -72,7 +72,7 @@ public: | ||||
|   typedef WilsonCompressor<SiteHalfCommSpinor,SiteHalfSpinor, SiteSpinor> Compressor; | ||||
|   typedef WilsonImplParams ImplParams; | ||||
|   typedef WilsonStencil<SiteSpinor, SiteHalfSpinor,ImplParams> StencilImpl; | ||||
|   typedef const typename StencilImpl::View_type StencilView; | ||||
|   typedef typename StencilImpl::View_type StencilView; | ||||
|      | ||||
|   ImplParams Params; | ||||
|  | ||||
| @@ -95,7 +95,7 @@ public: | ||||
| 					  const _Spinor &chi, | ||||
| 					  int mu, | ||||
| 					  StencilEntry *SE, | ||||
| 					  StencilView &St)  | ||||
| 					  const StencilView &St)  | ||||
|   { | ||||
|     multLink(phi,U,chi,mu); | ||||
|   } | ||||
|   | ||||
| @@ -50,15 +50,8 @@ public: | ||||
|   INHERIT_IMPL_TYPES(Impl); | ||||
|   typedef FermionOperator<Impl> Base; | ||||
|   typedef AcceleratorVector<int,STENCIL_MAX> StencilVector; | ||||
| public: | ||||
|     | ||||
| #ifdef GRID_SYCL | ||||
| #define SYCL_HACK | ||||
| #endif   | ||||
| #ifdef SYCL_HACK | ||||
|   static void HandDhopSiteSycl(StencilVector st_perm,StencilEntry *st_p, SiteDoubledGaugeField *U,SiteHalfSpinor  *buf, | ||||
| 			       int ss,int sU,const SiteSpinor *in, SiteSpinor *out); | ||||
| #endif | ||||
| public: | ||||
|  | ||||
|   static void DhopKernel(int Opt,StencilImpl &st,  DoubledGaugeField &U, SiteHalfSpinor * buf, | ||||
| 			 int Ls, int Nsite, const FermionField &in, FermionField &out, | ||||
| @@ -76,73 +69,87 @@ public: | ||||
|  | ||||
| private: | ||||
|  | ||||
|   static accelerator_inline void DhopDirK(StencilView &st, DoubledGaugeFieldView &U,SiteHalfSpinor * buf, | ||||
| 				   int sF, int sU, const FermionFieldView &in, FermionFieldView &out, int dirdisp, int gamma); | ||||
|   static accelerator_inline void DhopDirK(const StencilView &st, const DoubledGaugeFieldView &U, | ||||
| 					  SiteHalfSpinor * buf, int sF, int sU, | ||||
| 					  const FermionFieldView &in,const FermionFieldView &out, int dirdisp, int gamma); | ||||
|  | ||||
|   static accelerator_inline void DhopDirXp(StencilView &st,DoubledGaugeFieldView &U,SiteHalfSpinor *buf,int sF,int sU,const FermionFieldView &in,FermionFieldView &out,int dirdisp); | ||||
|   static accelerator_inline void DhopDirYp(StencilView &st,DoubledGaugeFieldView &U,SiteHalfSpinor *buf,int sF,int sU,const FermionFieldView &in,FermionFieldView &out,int dirdisp); | ||||
|   static accelerator_inline void DhopDirZp(StencilView &st,DoubledGaugeFieldView &U,SiteHalfSpinor *buf,int sF,int sU,const FermionFieldView &in,FermionFieldView &out,int dirdisp); | ||||
|   static accelerator_inline void DhopDirTp(StencilView &st,DoubledGaugeFieldView &U,SiteHalfSpinor *buf,int sF,int sU,const FermionFieldView &in,FermionFieldView &out,int dirdisp); | ||||
|   static accelerator_inline void DhopDirXm(StencilView &st,DoubledGaugeFieldView &U,SiteHalfSpinor *buf,int sF,int sU,const FermionFieldView &in,FermionFieldView &out,int dirdisp); | ||||
|   static accelerator_inline void DhopDirYm(StencilView &st,DoubledGaugeFieldView &U,SiteHalfSpinor *buf,int sF,int sU,const FermionFieldView &in,FermionFieldView &out,int dirdisp); | ||||
|   static accelerator_inline void DhopDirZm(StencilView &st,DoubledGaugeFieldView &U,SiteHalfSpinor *buf,int sF,int sU,const FermionFieldView &in,FermionFieldView &out,int dirdisp); | ||||
|   static accelerator_inline void DhopDirTm(StencilView &st,DoubledGaugeFieldView &U,SiteHalfSpinor *buf,int sF,int sU,const FermionFieldView &in,FermionFieldView &out,int dirdisp); | ||||
|   static accelerator_inline void DhopDirXp(const StencilView &st,const DoubledGaugeFieldView &U,SiteHalfSpinor *buf,int sF,int sU, | ||||
| 					   const FermionFieldView &in, const FermionFieldView &out,int dirdisp); | ||||
|   static accelerator_inline void DhopDirYp(const StencilView &st,const DoubledGaugeFieldView &U,SiteHalfSpinor *buf,int sF,int sU, | ||||
| 					   const FermionFieldView &in, const FermionFieldView &out,int dirdisp); | ||||
|   static accelerator_inline void DhopDirZp(const StencilView &st,const DoubledGaugeFieldView &U,SiteHalfSpinor *buf,int sF,int sU, | ||||
| 					   const FermionFieldView &in, const FermionFieldView &out,int dirdisp); | ||||
|   static accelerator_inline void DhopDirTp(const StencilView &st,const DoubledGaugeFieldView &U,SiteHalfSpinor *buf,int sF,int sU, | ||||
| 					   const FermionFieldView &in, const FermionFieldView &out,int dirdisp); | ||||
|   static accelerator_inline void DhopDirXm(const StencilView &st,const DoubledGaugeFieldView &U,SiteHalfSpinor *buf,int sF,int sU, | ||||
| 					   const FermionFieldView &in, const FermionFieldView &out,int dirdisp); | ||||
|   static accelerator_inline void DhopDirYm(const StencilView &st,const DoubledGaugeFieldView &U,SiteHalfSpinor *buf,int sF,int sU, | ||||
| 					   const FermionFieldView &in, const FermionFieldView &out,int dirdisp); | ||||
|   static accelerator_inline void DhopDirZm(const StencilView &st,const DoubledGaugeFieldView &U,SiteHalfSpinor *buf,int sF,int sU, | ||||
| 					   const FermionFieldView &in, const FermionFieldView &out,int dirdisp); | ||||
|   static accelerator_inline void DhopDirTm(const StencilView &st,const DoubledGaugeFieldView &U,SiteHalfSpinor *buf,int sF,int sU, | ||||
| 					   const FermionFieldView &in, const FermionFieldView &out,int dirdisp); | ||||
|        | ||||
|   // Specialised variants | ||||
|   static accelerator void GenericDhopSite(StencilView &st,  DoubledGaugeFieldView &U, SiteHalfSpinor * buf, | ||||
| 					  int sF, int sU, const FermionFieldView &in, FermionFieldView &out); | ||||
|   static accelerator void GenericDhopSite(const StencilView &st, | ||||
| 					  const DoubledGaugeFieldView &U, SiteHalfSpinor * buf, | ||||
| 					  int sF, int sU, const FermionFieldView &in, const FermionFieldView &out); | ||||
|         | ||||
|   static accelerator void GenericDhopSiteDag(StencilView &st,  DoubledGaugeFieldView &U, SiteHalfSpinor * buf, | ||||
| 						    int sF, int sU, const FermionFieldView &in, FermionFieldView &out); | ||||
|   static accelerator void GenericDhopSiteDag(const StencilView &st, const  DoubledGaugeFieldView &U, SiteHalfSpinor * buf, | ||||
| 					     int sF, int sU, const FermionFieldView &in, const FermionFieldView &out); | ||||
|     | ||||
|   static accelerator void GenericDhopSiteInt(StencilView &st,  DoubledGaugeFieldView &U, SiteHalfSpinor * buf, | ||||
| 						    int sF, int sU, const FermionFieldView &in, FermionFieldView &out); | ||||
|   static accelerator void GenericDhopSiteInt(const StencilView &st, const DoubledGaugeFieldView &U, SiteHalfSpinor * buf, | ||||
| 					     int sF, int sU, const FermionFieldView &in, const FermionFieldView &out); | ||||
|         | ||||
|   static accelerator void GenericDhopSiteDagInt(StencilView &st,  DoubledGaugeFieldView &U, SiteHalfSpinor * buf, | ||||
| 						int sF, int sU, const FermionFieldView &in, FermionFieldView &out); | ||||
|   static accelerator void GenericDhopSiteDagInt(const StencilView &st, const DoubledGaugeFieldView &U, SiteHalfSpinor * buf, | ||||
| 						int sF, int sU, const FermionFieldView &in, const FermionFieldView &out); | ||||
|     | ||||
|   static accelerator void GenericDhopSiteExt(StencilView &st,  DoubledGaugeFieldView &U, SiteHalfSpinor * buf, | ||||
| 					     int sF, int sU, const FermionFieldView &in, FermionFieldView &out); | ||||
|   static accelerator void GenericDhopSiteExt(const StencilView &st, const DoubledGaugeFieldView &U, SiteHalfSpinor * buf, | ||||
| 					     int sF, int sU, const FermionFieldView &in, const FermionFieldView &out); | ||||
|         | ||||
|   static accelerator void GenericDhopSiteDagExt(StencilView &st,  DoubledGaugeFieldView &U, SiteHalfSpinor * buf, | ||||
| 						       int sF, int sU, const FermionFieldView &in, FermionFieldView &out); | ||||
|   static accelerator void GenericDhopSiteDagExt(const StencilView &st, const DoubledGaugeFieldView &U, SiteHalfSpinor * buf, | ||||
| 						int sF, int sU, const FermionFieldView &in, const FermionFieldView &out); | ||||
|  | ||||
|   static void AsmDhopSite(StencilView &st,  DoubledGaugeFieldView &U, SiteHalfSpinor * buf, | ||||
| 			  int sF, int sU, int Ls, int Nsite, const FermionFieldView &in,FermionFieldView &out); | ||||
| // Keep Hand unrolled  | ||||
|   static accelerator void HandDhopSiteSycl(StencilVector st_perm, StencilEntry *st_p,  SiteDoubledGaugeField *U, SiteHalfSpinor * buf, | ||||
| 					   int sF, int sU, const SiteSpinor *in, SiteSpinor *out); | ||||
|  | ||||
|   static void AsmDhopSiteDag(StencilView &st,  DoubledGaugeFieldView &U, SiteHalfSpinor * buf, | ||||
| 			     int sF, int sU, int Ls, int Nsite, const FermionFieldView &in, FermionFieldView &out); | ||||
|   static accelerator void HandDhopSite(const StencilView &st, const DoubledGaugeFieldView &U, SiteHalfSpinor * buf, | ||||
| 				       int sF, int sU, const FermionFieldView &in,const FermionFieldView &out); | ||||
|     | ||||
|   static void AsmDhopSiteInt(StencilView &st,  DoubledGaugeFieldView &U, SiteHalfSpinor * buf, | ||||
| 			     int sF, int sU, int Ls, int Nsite, const FermionFieldView &in,FermionFieldView &out); | ||||
|   static accelerator void HandDhopSiteDag(const StencilView &st, const DoubledGaugeFieldView &U, SiteHalfSpinor * buf, | ||||
| 					  int sF, int sU, const FermionFieldView &in, const FermionFieldView &out); | ||||
|     | ||||
|   static void AsmDhopSiteDagInt(StencilView &st,  DoubledGaugeFieldView &U, SiteHalfSpinor * buf, | ||||
| 				int sF, int sU, int Ls, int Nsite, const FermionFieldView &in, FermionFieldView &out); | ||||
|   static accelerator void HandDhopSiteInt(const StencilView &st, const DoubledGaugeFieldView &U, SiteHalfSpinor * buf, | ||||
| 					  int sF, int sU, const FermionFieldView &in, const FermionFieldView &out); | ||||
|    | ||||
|   static void AsmDhopSiteExt(StencilView &st,  DoubledGaugeFieldView &U, SiteHalfSpinor * buf, | ||||
| 			     int sF, int sU, int Ls, int Nsite, const FermionFieldView &in,FermionFieldView &out); | ||||
|   static accelerator void HandDhopSiteDagInt(const StencilView &st, const DoubledGaugeFieldView &U, SiteHalfSpinor * buf, | ||||
| 					     int sF, int sU, const FermionFieldView &in, const FermionFieldView &out); | ||||
|    | ||||
|   static void AsmDhopSiteDagExt(StencilView &st,  DoubledGaugeFieldView &U, SiteHalfSpinor * buf, | ||||
| 				int sF, int sU, int Ls, int Nsite, const FermionFieldView &in, FermionFieldView &out); | ||||
|   static accelerator void HandDhopSiteExt(const StencilView &st, const DoubledGaugeFieldView &U, SiteHalfSpinor * buf, | ||||
| 					  int sF, int sU, const FermionFieldView &in, const FermionFieldView &out); | ||||
|     | ||||
| // Keep Hand unrolled temporarily   | ||||
|   static accelerator void HandDhopSite(StencilView &st,  DoubledGaugeFieldView &U, SiteHalfSpinor * buf, | ||||
| 				       int sF, int sU, const FermionFieldView &in, FermionFieldView &out); | ||||
|   static accelerator void HandDhopSiteDagExt(const StencilView &st, const DoubledGaugeFieldView &U, SiteHalfSpinor * buf, | ||||
| 					     int sF, int sU, const FermionFieldView &in, const FermionFieldView &out); | ||||
|   //AVX 512 ASM | ||||
|   static void AsmDhopSite(const StencilView &st,  const DoubledGaugeFieldView &U, SiteHalfSpinor * buf, | ||||
| 			  int sF, int sU, int Ls, int Nsite, const FermionFieldView &in,const FermionFieldView &out); | ||||
|    | ||||
|   static accelerator void HandDhopSiteDag(StencilView &st,  DoubledGaugeFieldView &U, SiteHalfSpinor * buf, | ||||
| 					  int sF, int sU, const FermionFieldView &in, FermionFieldView &out); | ||||
|   static void AsmDhopSiteDag(const StencilView &st,  const DoubledGaugeFieldView &U, SiteHalfSpinor * buf, | ||||
| 			     int sF, int sU, int Ls, int Nsite, const FermionFieldView &in, const FermionFieldView &out); | ||||
|    | ||||
|   static accelerator void HandDhopSiteInt(StencilView &st,  DoubledGaugeFieldView &U, SiteHalfSpinor * buf, | ||||
| 					  int sF, int sU, const FermionFieldView &in, FermionFieldView &out); | ||||
|   static void AsmDhopSiteInt(const StencilView &st,  const DoubledGaugeFieldView &U, SiteHalfSpinor * buf, | ||||
| 			     int sF, int sU, int Ls, int Nsite, const FermionFieldView &in,const FermionFieldView &out); | ||||
|    | ||||
|   static accelerator void HandDhopSiteDagInt(StencilView &st,  DoubledGaugeFieldView &U, SiteHalfSpinor * buf, | ||||
| 					     int sF, int sU, const FermionFieldView &in, FermionFieldView &out); | ||||
|   static void AsmDhopSiteDagInt(const StencilView &st,  const DoubledGaugeFieldView &U, SiteHalfSpinor * buf, | ||||
| 				int sF, int sU, int Ls, int Nsite, const FermionFieldView &in, const FermionFieldView &out); | ||||
|    | ||||
|   static accelerator void HandDhopSiteExt(StencilView &st,  DoubledGaugeFieldView &U, SiteHalfSpinor * buf, | ||||
| 					  int sF, int sU, const FermionFieldView &in, FermionFieldView &out); | ||||
|   static void AsmDhopSiteExt(const StencilView &st,  const DoubledGaugeFieldView &U, SiteHalfSpinor * buf, | ||||
| 			     int sF, int sU, int Ls, int Nsite, const FermionFieldView &in,const FermionFieldView &out); | ||||
|    | ||||
|   static void AsmDhopSiteDagExt(const StencilView &st,  const DoubledGaugeFieldView &U, SiteHalfSpinor * buf, | ||||
| 				int sF, int sU, int Ls, int Nsite, const FermionFieldView &in, const FermionFieldView &out); | ||||
|  | ||||
|   static accelerator void HandDhopSiteDagExt(StencilView &st,  DoubledGaugeFieldView &U, SiteHalfSpinor * buf, | ||||
| 					     int sF, int sU, const FermionFieldView &in, FermionFieldView &out); | ||||
|  public: | ||||
|  WilsonKernels(const ImplParams &p = ImplParams()) : Base(p){}; | ||||
| }; | ||||
|   | ||||
| @@ -618,11 +618,13 @@ Author: paboyle <paboyle@ph.ed.ac.uk> | ||||
| NAMESPACE_BEGIN(Grid); | ||||
|  | ||||
| template <class Impl> | ||||
| void StaggeredKernels<Impl>::DhopSiteAsm(StencilView &st, | ||||
| 					 DoubledGaugeFieldView &U, | ||||
| 					 DoubledGaugeFieldView &UUU, | ||||
| void StaggeredKernels<Impl>::DhopSiteAsm(const StencilView &st, | ||||
| 					 const DoubledGaugeFieldView &U, | ||||
| 					 const DoubledGaugeFieldView &UUU, | ||||
|  					 SiteSpinor *buf, int sF, | ||||
| 					 int sU, const FermionFieldView &in, FermionFieldView &out,int dag)  | ||||
| 					 int sU, | ||||
| 					 const FermionFieldView &in, | ||||
| 					 const FermionFieldView &out,int dag)  | ||||
| { | ||||
|   assert(0); | ||||
| }; | ||||
| @@ -683,11 +685,13 @@ void StaggeredKernels<Impl>::DhopSiteAsm(StencilView &st, | ||||
|  | ||||
|   // This is the single precision 5th direction vectorised kernel | ||||
| #include <Grid/simd/Intel512single.h> | ||||
| template <> void StaggeredKernels<StaggeredVec5dImplF>::DhopSiteAsm(StencilView &st, | ||||
| 								    DoubledGaugeFieldView &U, | ||||
| 								    DoubledGaugeFieldView &UUU, | ||||
| template <> void StaggeredKernels<StaggeredVec5dImplF>::DhopSiteAsm(const StencilView &st, | ||||
| 								    const DoubledGaugeFieldView &U, | ||||
| 								    const DoubledGaugeFieldView &UUU, | ||||
|  								    SiteSpinor *buf, int sF, | ||||
| 								    int sU, const FermionFieldView &in, FermionFieldView &out,int dag)  | ||||
| 								    int sU, | ||||
| 								    const FermionFieldView &in, | ||||
| 								    const FermionFieldView &out,int dag)  | ||||
| { | ||||
| #ifdef AVX512 | ||||
|   uint64_t gauge0,gauge1,gauge2,gauge3; | ||||
| @@ -738,11 +742,13 @@ template <> void StaggeredKernels<StaggeredVec5dImplF>::DhopSiteAsm(StencilView | ||||
| } | ||||
|  | ||||
| #include <Grid/simd/Intel512double.h> | ||||
| template <> void StaggeredKernels<StaggeredVec5dImplD>::DhopSiteAsm(StencilView &st,  | ||||
| 								    DoubledGaugeFieldView &U, | ||||
| 								    DoubledGaugeFieldView &UUU, | ||||
| template <> void StaggeredKernels<StaggeredVec5dImplD>::DhopSiteAsm(const StencilView &st,  | ||||
| 								    const DoubledGaugeFieldView &U, | ||||
| 								    const DoubledGaugeFieldView &UUU, | ||||
|  								    SiteSpinor *buf, int sF, | ||||
| 								    int sU, const FermionFieldView &in, FermionFieldView &out, int dag)  | ||||
| 								    int sU, | ||||
| 								    const FermionFieldView &in, | ||||
| 								    const FermionFieldView &out, int dag)  | ||||
| { | ||||
| #ifdef AVX512 | ||||
|   uint64_t gauge0,gauge1,gauge2,gauge3; | ||||
| @@ -824,11 +830,13 @@ template <> void StaggeredKernels<StaggeredVec5dImplD>::DhopSiteAsm(StencilView | ||||
|   // This is the single precision 5th direction vectorised kernel | ||||
|  | ||||
| #include <Grid/simd/Intel512single.h> | ||||
| template <> void StaggeredKernels<StaggeredImplF>::DhopSiteAsm(StencilView &st,  | ||||
| 							       DoubledGaugeFieldView &U, | ||||
| 							       DoubledGaugeFieldView &UUU, | ||||
| template <> void StaggeredKernels<StaggeredImplF>::DhopSiteAsm(const StencilView &st,  | ||||
| 							       const DoubledGaugeFieldView &U, | ||||
| 							       const DoubledGaugeFieldView &UUU, | ||||
|  							       SiteSpinor *buf, int sF, | ||||
| 							       int sU, const FermionFieldView &in, FermionFieldView &out,int dag)  | ||||
| 							       int sU, | ||||
| 							       const FermionFieldView &in, | ||||
| 							       const FermionFieldView &out,int dag)  | ||||
| { | ||||
| #ifdef AVX512 | ||||
|   uint64_t gauge0,gauge1,gauge2,gauge3; | ||||
| @@ -893,11 +901,13 @@ template <> void StaggeredKernels<StaggeredImplF>::DhopSiteAsm(StencilView &st, | ||||
| } | ||||
|  | ||||
| #include <Grid/simd/Intel512double.h> | ||||
| template <> void StaggeredKernels<StaggeredImplD>::DhopSiteAsm(StencilView &st,  | ||||
| 							       DoubledGaugeFieldView &U, | ||||
| 							       DoubledGaugeFieldView &UUU, | ||||
| template <> void StaggeredKernels<StaggeredImplD>::DhopSiteAsm(const StencilView &st,  | ||||
| 							       const DoubledGaugeFieldView &U, | ||||
| 							       const DoubledGaugeFieldView &UUU, | ||||
|  							       SiteSpinor *buf, int sF, | ||||
| 							       int sU, const FermionFieldView &in, FermionFieldView &out,int dag)  | ||||
| 							       int sU, | ||||
| 							       const FermionFieldView &in, | ||||
| 							       const FermionFieldView &out,int dag)  | ||||
| { | ||||
| #ifdef AVX512 | ||||
|   uint64_t gauge0,gauge1,gauge2,gauge3; | ||||
|   | ||||
| @@ -147,10 +147,12 @@ NAMESPACE_BEGIN(Grid); | ||||
|  | ||||
| template <class Impl> | ||||
| template <int Naik> accelerator_inline | ||||
| void StaggeredKernels<Impl>::DhopSiteHand(StencilView &st, | ||||
| 					  DoubledGaugeFieldView &U,DoubledGaugeFieldView &UUU, | ||||
| void StaggeredKernels<Impl>::DhopSiteHand(const StencilView &st, | ||||
| 					  const DoubledGaugeFieldView &U, | ||||
| 					  const DoubledGaugeFieldView &UUU, | ||||
|  					  SiteSpinor *buf, int sF, int sU,  | ||||
| 					  const FermionFieldView &in, FermionFieldView &out,int dag)  | ||||
| 					  const FermionFieldView &in, | ||||
| 					  const FermionFieldView &out,int dag)  | ||||
| { | ||||
|   typedef typename Simd::scalar_type S; | ||||
|   typedef typename Simd::vector_type V; | ||||
| @@ -222,10 +224,12 @@ void StaggeredKernels<Impl>::DhopSiteHand(StencilView &st, | ||||
|  | ||||
| template <class Impl> | ||||
| template <int Naik> accelerator_inline | ||||
| void StaggeredKernels<Impl>::DhopSiteHandInt(StencilView &st,  | ||||
| 					     DoubledGaugeFieldView &U, DoubledGaugeFieldView &UUU, | ||||
| void StaggeredKernels<Impl>::DhopSiteHandInt(const StencilView &st,  | ||||
| 					     const DoubledGaugeFieldView &U, | ||||
| 					     const DoubledGaugeFieldView &UUU, | ||||
|  					     SiteSpinor *buf, int sF, int sU,  | ||||
| 					     const FermionFieldView &in, FermionFieldView &out,int dag)  | ||||
| 					     const FermionFieldView &in, | ||||
| 					     const FermionFieldView &out,int dag)  | ||||
| { | ||||
|   typedef typename Simd::scalar_type S; | ||||
|   typedef typename Simd::vector_type V; | ||||
| @@ -301,10 +305,12 @@ void StaggeredKernels<Impl>::DhopSiteHandInt(StencilView &st, | ||||
|  | ||||
| template <class Impl> | ||||
| template <int Naik> accelerator_inline | ||||
| void StaggeredKernels<Impl>::DhopSiteHandExt(StencilView &st, | ||||
| 					     DoubledGaugeFieldView &U, DoubledGaugeFieldView &UUU, | ||||
| void StaggeredKernels<Impl>::DhopSiteHandExt(const StencilView &st, | ||||
| 					     const DoubledGaugeFieldView &U, | ||||
| 					     const DoubledGaugeFieldView &UUU, | ||||
|  					     SiteSpinor *buf, int sF, int sU,  | ||||
| 					     const FermionFieldView &in, FermionFieldView &out,int dag)  | ||||
| 					     const FermionFieldView &in, | ||||
| 					     const FermionFieldView &out,int dag)  | ||||
| { | ||||
|   typedef typename Simd::scalar_type S; | ||||
|   typedef typename Simd::vector_type V; | ||||
|   | ||||
| @@ -79,10 +79,10 @@ StaggeredKernels<Impl>::StaggeredKernels(const ImplParams &p) : Base(p){}; | ||||
| //////////////////////////////////////////////////////////////////////////////////// | ||||
| template <class Impl> | ||||
| template <int Naik> accelerator_inline | ||||
| void StaggeredKernels<Impl>::DhopSiteGeneric(StencilView &st,  | ||||
| 					     DoubledGaugeFieldView &U, DoubledGaugeFieldView &UUU, | ||||
| void StaggeredKernels<Impl>::DhopSiteGeneric(const StencilView &st,  | ||||
| 					     const DoubledGaugeFieldView &U, const DoubledGaugeFieldView &UUU, | ||||
|  					     SiteSpinor *buf, int sF, int sU,  | ||||
| 					     const FermionFieldView &in, FermionFieldView &out, int dag)  | ||||
| 					     const FermionFieldView &in, const FermionFieldView &out, int dag)  | ||||
| { | ||||
|   const SiteSpinor *chi_p; | ||||
|   SiteSpinor chi; | ||||
| @@ -127,10 +127,11 @@ void StaggeredKernels<Impl>::DhopSiteGeneric(StencilView &st, | ||||
|   /////////////////////////////////////////////////// | ||||
| template <class Impl> | ||||
| template <int Naik> accelerator_inline | ||||
| void StaggeredKernels<Impl>::DhopSiteGenericInt(StencilView &st,  | ||||
| 						DoubledGaugeFieldView &U, DoubledGaugeFieldView &UUU, | ||||
| void StaggeredKernels<Impl>::DhopSiteGenericInt(const StencilView &st,  | ||||
| 						const DoubledGaugeFieldView &U, const DoubledGaugeFieldView &UUU, | ||||
|  						SiteSpinor *buf, int sF, int sU,  | ||||
| 						const FermionFieldView &in, FermionFieldView &out,int dag) { | ||||
| 						const FermionFieldView &in, const FermionFieldView &out,int dag) | ||||
| { | ||||
|   const SiteSpinor *chi_p; | ||||
|   SiteSpinor chi; | ||||
|   SiteSpinor Uchi; | ||||
| @@ -175,10 +176,13 @@ void StaggeredKernels<Impl>::DhopSiteGenericInt(StencilView &st, | ||||
|   /////////////////////////////////////////////////// | ||||
| template <class Impl> | ||||
| template <int Naik> accelerator_inline | ||||
| void StaggeredKernels<Impl>::DhopSiteGenericExt(StencilView &st,  | ||||
| 						DoubledGaugeFieldView &U, DoubledGaugeFieldView &UUU, | ||||
| void StaggeredKernels<Impl>::DhopSiteGenericExt(const StencilView &st,  | ||||
| 						const DoubledGaugeFieldView &U, | ||||
| 						const DoubledGaugeFieldView &UUU, | ||||
|  						SiteSpinor *buf, int sF, int sU, | ||||
| 						const FermionFieldView &in, FermionFieldView &out,int dag) { | ||||
| 						const FermionFieldView &in, | ||||
| 						const FermionFieldView &out,int dag) | ||||
| { | ||||
|   const SiteSpinor *chi_p; | ||||
|   //  SiteSpinor chi; | ||||
|   SiteSpinor Uchi; | ||||
| @@ -225,8 +229,13 @@ void StaggeredKernels<Impl>::DhopSiteGenericExt(StencilView &st, | ||||
| // Driving / wrapping routine to select right kernel | ||||
| //////////////////////////////////////////////////////////////////////////////////// | ||||
| template <class Impl>  | ||||
| void StaggeredKernels<Impl>::DhopDirKernel(StencilImpl &st, DoubledGaugeFieldView &U, DoubledGaugeFieldView &UUU, SiteSpinor * buf, | ||||
| 					   int sF, int sU, const FermionFieldView &in, FermionFieldView &out, int dir,int disp) | ||||
| void StaggeredKernels<Impl>::DhopDirKernel(StencilImpl &st, | ||||
| 					   const DoubledGaugeFieldView &U, | ||||
| 					   const DoubledGaugeFieldView &UUU, | ||||
| 					   SiteSpinor * buf, | ||||
| 					   int sF, int sU, | ||||
| 					   const FermionFieldView &in, | ||||
| 					   const FermionFieldView &out, int dir,int disp) | ||||
| { | ||||
|   // Disp should be either +1,-1,+3,-3 | ||||
|   // What about "dag" ? | ||||
| @@ -254,7 +263,8 @@ void StaggeredKernels<Impl>::DhopDirKernel(StencilImpl &st, DoubledGaugeFieldVie | ||||
|   }); | ||||
|  | ||||
| template <class Impl>  | ||||
| void StaggeredKernels<Impl>::DhopImproved(StencilImpl &st, LebesgueOrder &lo,  | ||||
| void StaggeredKernels<Impl>::DhopImproved(StencilImpl &st, | ||||
| 					  LebesgueOrder &lo,  | ||||
| 					  DoubledGaugeField &U, DoubledGaugeField &UUU,  | ||||
| 					  const FermionField &in, FermionField &out, int dag, int interior,int exterior) | ||||
| { | ||||
|   | ||||
| @@ -397,7 +397,6 @@ void WilsonFermion<Impl>::DhopDerivEO(GaugeField &mat, const FermionField &U, co | ||||
| template <class Impl> | ||||
| void WilsonFermion<Impl>::Dhop(const FermionField &in, FermionField &out, int dag) | ||||
| { | ||||
|   DhopCalls+=2; | ||||
|   conformable(in.Grid(), _grid);  // verifies full grid | ||||
|   conformable(in.Grid(), out.Grid()); | ||||
|  | ||||
| @@ -409,7 +408,6 @@ void WilsonFermion<Impl>::Dhop(const FermionField &in, FermionField &out, int da | ||||
| template <class Impl> | ||||
| void WilsonFermion<Impl>::DhopOE(const FermionField &in, FermionField &out, int dag) | ||||
| { | ||||
|   DhopCalls++; | ||||
|   conformable(in.Grid(), _cbgrid);    // verifies half grid | ||||
|   conformable(in.Grid(), out.Grid());  // drops the cb check | ||||
|  | ||||
| @@ -422,7 +420,6 @@ void WilsonFermion<Impl>::DhopOE(const FermionField &in, FermionField &out, int | ||||
| template <class Impl> | ||||
| void WilsonFermion<Impl>::DhopEO(const FermionField &in, FermionField &out,int dag) | ||||
| { | ||||
|   DhopCalls++; | ||||
|   conformable(in.Grid(), _cbgrid);    // verifies half grid | ||||
|   conformable(in.Grid(), out.Grid());  // drops the cb check | ||||
|  | ||||
|   | ||||
| @@ -38,46 +38,46 @@ NAMESPACE_BEGIN(Grid); | ||||
|  | ||||
| /////////////////////////////////////////////////////////// | ||||
| // Default to no assembler implementation | ||||
| // Will specialise to  | ||||
| // Will specialise to AVX512 if available | ||||
| /////////////////////////////////////////////////////////// | ||||
| template<class Impl> void  | ||||
| WilsonKernels<Impl >::AsmDhopSite(StencilView &st, DoubledGaugeFieldView &U,SiteHalfSpinor *buf, | ||||
| 				  int ss,int ssU,int Ls,int Ns,const FermionFieldView &in, FermionFieldView &out) | ||||
| WilsonKernels<Impl >::AsmDhopSite(const StencilView &st, const DoubledGaugeFieldView &U,SiteHalfSpinor *buf, | ||||
| 				  int ss,int ssU,int Ls,int Ns,const FermionFieldView &in, const FermionFieldView &out) | ||||
| { | ||||
|   assert(0); | ||||
| } | ||||
|  | ||||
| template<class Impl> void  | ||||
| WilsonKernels<Impl >::AsmDhopSiteDag(StencilView &st, DoubledGaugeFieldView &U,SiteHalfSpinor *buf, | ||||
| 				     int ss,int ssU,int Ls,int Ns,const FermionFieldView &in, FermionFieldView &out) | ||||
| WilsonKernels<Impl >::AsmDhopSiteDag(const StencilView &st, const DoubledGaugeFieldView &U,SiteHalfSpinor *buf, | ||||
| 				     int ss,int ssU,int Ls,int Ns,const FermionFieldView &in, const FermionFieldView &out) | ||||
| { | ||||
|   assert(0); | ||||
| } | ||||
|  | ||||
| template<class Impl> void  | ||||
| WilsonKernels<Impl >::AsmDhopSiteInt(StencilView &st, DoubledGaugeFieldView &U,SiteHalfSpinor *buf, | ||||
| 				     int ss,int ssU,int Ls,int Ns,const FermionFieldView &in, FermionFieldView &out) | ||||
| WilsonKernels<Impl >::AsmDhopSiteInt(const StencilView &st, const DoubledGaugeFieldView &U,SiteHalfSpinor *buf, | ||||
| 				     int ss,int ssU,int Ls,int Ns,const FermionFieldView &in, const FermionFieldView &out) | ||||
| { | ||||
|   assert(0); | ||||
| } | ||||
|  | ||||
| template<class Impl> void  | ||||
| WilsonKernels<Impl >::AsmDhopSiteDagInt(StencilView &st, DoubledGaugeFieldView &U,SiteHalfSpinor *buf, | ||||
| 					int ss,int ssU,int Ls,int Ns,const FermionFieldView &in, FermionFieldView &out) | ||||
| WilsonKernels<Impl >::AsmDhopSiteDagInt(const StencilView &st, const DoubledGaugeFieldView &U,SiteHalfSpinor *buf, | ||||
| 					int ss,int ssU,int Ls,int Ns,const FermionFieldView &in, const FermionFieldView &out) | ||||
| { | ||||
|   assert(0); | ||||
| } | ||||
|  | ||||
| template<class Impl> void  | ||||
| WilsonKernels<Impl >::AsmDhopSiteExt(StencilView &st, DoubledGaugeFieldView &U,SiteHalfSpinor *buf, | ||||
| 				     int ss,int ssU,int Ls,int Ns,const FermionFieldView &in, FermionFieldView &out) | ||||
| WilsonKernels<Impl >::AsmDhopSiteExt(const StencilView &st, const DoubledGaugeFieldView &U,SiteHalfSpinor *buf, | ||||
| 				     int ss,int ssU,int Ls,int Ns,const FermionFieldView &in, const FermionFieldView &out) | ||||
| { | ||||
|   assert(0); | ||||
| } | ||||
|  | ||||
| template<class Impl> void  | ||||
| WilsonKernels<Impl >::AsmDhopSiteDagExt(StencilView &st, DoubledGaugeFieldView &U,SiteHalfSpinor *buf, | ||||
| 					int ss,int ssU,int Ls,int Ns,const FermionFieldView &in, FermionFieldView &out) | ||||
| WilsonKernels<Impl >::AsmDhopSiteDagExt(const StencilView &st, const DoubledGaugeFieldView &U,SiteHalfSpinor *buf, | ||||
| 					int ss,int ssU,int Ls,int Ns,const FermionFieldView &in, const FermionFieldView &out) | ||||
| { | ||||
|   assert(0); | ||||
| } | ||||
|   | ||||
| @@ -647,8 +647,13 @@ NAMESPACE_BEGIN(Grid); | ||||
|  | ||||
| #define HAND_SPECIALISE_GPARITY(IMPL)					\ | ||||
|   template<> accelerator_inline void					\ | ||||
|   WilsonKernels<IMPL>::HandDhopSite(StencilView &st, DoubledGaugeFieldView &U,SiteHalfSpinor  *buf, \ | ||||
| 				    int ss,int sU,const FermionFieldView &in, FermionFieldView &out) \ | ||||
|   WilsonKernels<IMPL>::HandDhopSiteSycl(StencilVector st_perm, StencilEntry *st_p, \ | ||||
| 					SiteDoubledGaugeField *U, SiteHalfSpinor * buf, \ | ||||
| 					int sF, int sU, const SiteSpinor *in, SiteSpinor *out) {} \ | ||||
|   									\ | ||||
|   template<> accelerator_inline void						\ | ||||
|   WilsonKernels<IMPL>::HandDhopSite(const StencilView &st, const DoubledGaugeFieldView &U,SiteHalfSpinor  *buf, \ | ||||
| 				    int ss,int sU,const FermionFieldView &in, const FermionFieldView &out) \ | ||||
|   {									\ | ||||
|     typedef IMPL Impl;							\ | ||||
|     typedef typename Simd::scalar_type S;				\ | ||||
| @@ -663,8 +668,8 @@ NAMESPACE_BEGIN(Grid); | ||||
|   }									\ | ||||
| 									\ | ||||
|   template<> accelerator_inline void						\ | ||||
|   WilsonKernels<IMPL>::HandDhopSiteDag(StencilView &st, DoubledGaugeFieldView &U,SiteHalfSpinor *buf, \ | ||||
| 				       int ss,int sU,const FermionFieldView &in, FermionFieldView &out) \ | ||||
|   WilsonKernels<IMPL>::HandDhopSiteDag(const StencilView &st, const DoubledGaugeFieldView &U,SiteHalfSpinor *buf, \ | ||||
| 				       int ss,int sU,const FermionFieldView &in, const FermionFieldView &out) \ | ||||
|   {									\ | ||||
|     typedef IMPL Impl;							\ | ||||
|     typedef typename Simd::scalar_type S;				\ | ||||
| @@ -679,8 +684,8 @@ NAMESPACE_BEGIN(Grid); | ||||
|   }									\ | ||||
| 									\ | ||||
|   template<> accelerator_inline void						\ | ||||
|   WilsonKernels<IMPL>::HandDhopSiteInt(StencilView &st, DoubledGaugeFieldView &U,SiteHalfSpinor  *buf, \ | ||||
| 				       int ss,int sU,const FermionFieldView &in, FermionFieldView &out) \ | ||||
|   WilsonKernels<IMPL>::HandDhopSiteInt(const StencilView &st, const DoubledGaugeFieldView &U,SiteHalfSpinor  *buf, \ | ||||
| 				       int ss,int sU,const FermionFieldView &in, const FermionFieldView &out) \ | ||||
|   {									\ | ||||
|     typedef IMPL Impl;							\ | ||||
|     typedef typename Simd::scalar_type S;				\ | ||||
| @@ -695,8 +700,8 @@ NAMESPACE_BEGIN(Grid); | ||||
|   }									\ | ||||
| 									\ | ||||
|   template<> accelerator_inline void						\ | ||||
|   WilsonKernels<IMPL>::HandDhopSiteDagInt(StencilView &st, DoubledGaugeFieldView &U,SiteHalfSpinor *buf, \ | ||||
| 					  int ss,int sU,const FermionFieldView &in, FermionFieldView &out) \ | ||||
|   WilsonKernels<IMPL>::HandDhopSiteDagInt(const StencilView &st, const DoubledGaugeFieldView &U,SiteHalfSpinor *buf, \ | ||||
| 					  int ss,int sU,const FermionFieldView &in, const FermionFieldView &out) \ | ||||
|   {									\ | ||||
|     typedef IMPL Impl;							\ | ||||
|     typedef typename Simd::scalar_type S;				\ | ||||
| @@ -711,8 +716,8 @@ NAMESPACE_BEGIN(Grid); | ||||
|   }									\ | ||||
| 									\ | ||||
|   template<> accelerator_inline void							\ | ||||
|   WilsonKernels<IMPL>::HandDhopSiteExt(StencilView &st, DoubledGaugeFieldView &U,SiteHalfSpinor  *buf, \ | ||||
| 				       int ss,int sU,const FermionFieldView &in, FermionFieldView &out) \ | ||||
|   WilsonKernels<IMPL>::HandDhopSiteExt(const StencilView &st, const DoubledGaugeFieldView &U,SiteHalfSpinor  *buf, \ | ||||
| 				       int ss,int sU,const FermionFieldView &in, const FermionFieldView &out) \ | ||||
|   {									\ | ||||
|     typedef IMPL Impl;							\ | ||||
|     typedef typename Simd::scalar_type S;				\ | ||||
| @@ -728,8 +733,8 @@ NAMESPACE_BEGIN(Grid); | ||||
|     HAND_DOP_SITE_EXT(1, LOAD_CHI_GPARITY,LOAD_CHIMU_GPARITY,MULT_2SPIN_GPARITY); \ | ||||
|   }									\ | ||||
|   template<> accelerator_inline void						\ | ||||
|   WilsonKernels<IMPL>::HandDhopSiteDagExt(StencilView &st, DoubledGaugeFieldView &U,SiteHalfSpinor *buf, \ | ||||
| 					  int ss,int sU,const FermionFieldView &in, FermionFieldView &out) \ | ||||
|   WilsonKernels<IMPL>::HandDhopSiteDagExt(const StencilView &st, const DoubledGaugeFieldView &U,SiteHalfSpinor *buf, \ | ||||
| 					  int ss,int sU,const FermionFieldView &in, const FermionFieldView &out) \ | ||||
|   {									\ | ||||
|     typedef IMPL Impl;							\ | ||||
|     typedef typename Simd::scalar_type S;				\ | ||||
|   | ||||
| @@ -76,24 +76,7 @@ Author: paboyle <paboyle@ph.ed.ac.uk> | ||||
|  | ||||
| #define REGISTER | ||||
|  | ||||
| #ifdef GRID_SIMT | ||||
| #define LOAD_CHIMU(ptype)		\ | ||||
|   {const SiteSpinor & ref (in[offset]);	\ | ||||
|     Chimu_00=coalescedReadPermute<ptype>(ref()(0)(0),perm,lane);	\ | ||||
|     Chimu_01=coalescedReadPermute<ptype>(ref()(0)(1),perm,lane);		\ | ||||
|     Chimu_02=coalescedReadPermute<ptype>(ref()(0)(2),perm,lane);		\ | ||||
|     Chimu_10=coalescedReadPermute<ptype>(ref()(1)(0),perm,lane);		\ | ||||
|     Chimu_11=coalescedReadPermute<ptype>(ref()(1)(1),perm,lane);		\ | ||||
|     Chimu_12=coalescedReadPermute<ptype>(ref()(1)(2),perm,lane);		\ | ||||
|     Chimu_20=coalescedReadPermute<ptype>(ref()(2)(0),perm,lane);		\ | ||||
|     Chimu_21=coalescedReadPermute<ptype>(ref()(2)(1),perm,lane);		\ | ||||
|     Chimu_22=coalescedReadPermute<ptype>(ref()(2)(2),perm,lane);		\ | ||||
|     Chimu_30=coalescedReadPermute<ptype>(ref()(3)(0),perm,lane);		\ | ||||
|     Chimu_31=coalescedReadPermute<ptype>(ref()(3)(1),perm,lane);		\ | ||||
|     Chimu_32=coalescedReadPermute<ptype>(ref()(3)(2),perm,lane);	} | ||||
| #define PERMUTE_DIR(dir) ; | ||||
| #else | ||||
| #define LOAD_CHIMU(ptype)		\ | ||||
| #define LOAD_CHIMU \ | ||||
|   {const SiteSpinor & ref (in[offset]);	\ | ||||
|     Chimu_00=ref()(0)(0);\ | ||||
|     Chimu_01=ref()(0)(1);\ | ||||
| @@ -108,24 +91,24 @@ Author: paboyle <paboyle@ph.ed.ac.uk> | ||||
|     Chimu_31=ref()(3)(1);\ | ||||
|     Chimu_32=ref()(3)(2);} | ||||
|  | ||||
| #define PERMUTE_DIR(dir)			\ | ||||
|   permute##dir(Chi_00,Chi_00);	\ | ||||
|       permute##dir(Chi_01,Chi_01);\ | ||||
|       permute##dir(Chi_02,Chi_02);\ | ||||
|       permute##dir(Chi_10,Chi_10);	\ | ||||
|       permute##dir(Chi_11,Chi_11);\ | ||||
|       permute##dir(Chi_12,Chi_12); | ||||
|  | ||||
| #endif | ||||
| #define LOAD_CHI\ | ||||
|   {const SiteHalfSpinor &ref(buf[offset]);	\ | ||||
|     Chi_00 = ref()(0)(0);\ | ||||
|     Chi_01 = ref()(0)(1);\ | ||||
|     Chi_02 = ref()(0)(2);\ | ||||
|     Chi_10 = ref()(1)(0);\ | ||||
|     Chi_11 = ref()(1)(1);\ | ||||
|     Chi_12 = ref()(1)(2);} | ||||
|  | ||||
| // To splat or not to splat depends on the implementation | ||||
| #define MULT_2SPIN(A)\ | ||||
|   {auto & ref(U[sU](A));			\ | ||||
|     U_00=coalescedRead(ref()(0,0),lane);				\ | ||||
|     U_10=coalescedRead(ref()(1,0),lane);				\ | ||||
|     U_20=coalescedRead(ref()(2,0),lane);				\ | ||||
|     U_01=coalescedRead(ref()(0,1),lane);				\ | ||||
|     U_11=coalescedRead(ref()(1,1),lane);				\ | ||||
|     U_21=coalescedRead(ref()(2,1),lane);				\ | ||||
|    Impl::loadLinkElement(U_00,ref()(0,0));	\ | ||||
|    Impl::loadLinkElement(U_10,ref()(1,0));	\ | ||||
|    Impl::loadLinkElement(U_20,ref()(2,0));	\ | ||||
|    Impl::loadLinkElement(U_01,ref()(0,1));	\ | ||||
|    Impl::loadLinkElement(U_11,ref()(1,1));	\ | ||||
|    Impl::loadLinkElement(U_21,ref()(2,1));	\ | ||||
|     UChi_00 = U_00*Chi_00;\ | ||||
|     UChi_10 = U_00*Chi_10;\ | ||||
|     UChi_01 = U_10*Chi_00;\ | ||||
| @@ -138,9 +121,9 @@ Author: paboyle <paboyle@ph.ed.ac.uk> | ||||
|     UChi_11+= U_11*Chi_11;\ | ||||
|     UChi_02+= U_21*Chi_01;\ | ||||
|     UChi_12+= U_21*Chi_11;\ | ||||
|     U_00=coalescedRead(ref()(0,2),lane);				\ | ||||
|     U_10=coalescedRead(ref()(1,2),lane);				\ | ||||
|     U_20=coalescedRead(ref()(2,2),lane);				\ | ||||
|     Impl::loadLinkElement(U_00,ref()(0,2));	\ | ||||
|     Impl::loadLinkElement(U_10,ref()(1,2));	\ | ||||
|     Impl::loadLinkElement(U_20,ref()(2,2));	\ | ||||
|     UChi_00+= U_00*Chi_02;\ | ||||
|     UChi_10+= U_00*Chi_12;\ | ||||
|     UChi_01+= U_10*Chi_02;\ | ||||
| @@ -148,14 +131,14 @@ Author: paboyle <paboyle@ph.ed.ac.uk> | ||||
|     UChi_02+= U_20*Chi_02;\ | ||||
|     UChi_12+= U_20*Chi_12;} | ||||
|  | ||||
| #define LOAD_CHI				\ | ||||
|   {const SiteHalfSpinor &ref(buf[offset]);	\ | ||||
|     Chi_00 = coalescedRead(ref()(0)(0),lane);	\ | ||||
|     Chi_01 = coalescedRead(ref()(0)(1),lane);	\ | ||||
|     Chi_02 = coalescedRead(ref()(0)(2),lane);	\ | ||||
|     Chi_10 = coalescedRead(ref()(1)(0),lane);	\ | ||||
|     Chi_11 = coalescedRead(ref()(1)(1),lane);	\ | ||||
|     Chi_12 = coalescedRead(ref()(1)(2),lane);} | ||||
|  | ||||
| #define PERMUTE_DIR(dir)			\ | ||||
|       permute##dir(Chi_00,Chi_00);\ | ||||
|       permute##dir(Chi_01,Chi_01);\ | ||||
|       permute##dir(Chi_02,Chi_02);\ | ||||
|       permute##dir(Chi_10,Chi_10);\ | ||||
|       permute##dir(Chi_11,Chi_11);\ | ||||
|       permute##dir(Chi_12,Chi_12); | ||||
|  | ||||
| //      hspin(0)=fspin(0)+timesI(fspin(3)); | ||||
| //      hspin(1)=fspin(1)+timesI(fspin(2)); | ||||
| @@ -370,13 +353,13 @@ Author: paboyle <paboyle@ph.ed.ac.uk> | ||||
|   result_31-= UChi_11;	\ | ||||
|   result_32-= UChi_12; | ||||
|  | ||||
| #define HAND_STENCIL_LEGB(PROJ,PERM,DIR,RECON)	\ | ||||
| #define HAND_STENCIL_LEG(PROJ,PERM,DIR,RECON)	\ | ||||
|   SE=st.GetEntry(ptype,DIR,ss);			\ | ||||
|   offset = SE->_offset;				\ | ||||
|   local  = SE->_is_local;			\ | ||||
|   perm   = SE->_permute;			\ | ||||
|   if ( local ) {				\ | ||||
|     LOAD_CHIMU(PERM);				\ | ||||
|     LOAD_CHIMU;					\ | ||||
|     PROJ;					\ | ||||
|     if ( perm) {				\ | ||||
|       PERMUTE_DIR(PERM);			\ | ||||
| @@ -384,37 +367,6 @@ Author: paboyle <paboyle@ph.ed.ac.uk> | ||||
|   } else {					\ | ||||
|     LOAD_CHI;					\ | ||||
|   }						\ | ||||
|   acceleratorSynchronise();			\ | ||||
|   MULT_2SPIN(DIR);				\ | ||||
|   RECON;					 | ||||
|  | ||||
| #define HAND_STENCIL_LEG(PROJ,PERM,DIR,RECON)	\ | ||||
|   SE=&st_p[DIR+8*ss];				\ | ||||
|   ptype=st_perm[DIR];				\ | ||||
|   offset = SE->_offset;				\ | ||||
|   local  = SE->_is_local;			\ | ||||
|   perm   = SE->_permute;			\ | ||||
|   if ( local ) {				\ | ||||
|     LOAD_CHIMU(PERM);				\ | ||||
|     PROJ;					\ | ||||
|     if ( perm) {				\ | ||||
|       PERMUTE_DIR(PERM);			\ | ||||
|     }						\ | ||||
|   } else {					\ | ||||
|     LOAD_CHI;					\ | ||||
|   }						\ | ||||
|   acceleratorSynchronise();			\ | ||||
|   MULT_2SPIN(DIR);				\ | ||||
|   RECON;					 | ||||
|  | ||||
| #define HAND_STENCIL_LEGA(PROJ,PERM,DIR,RECON)				\ | ||||
|   SE=&st_p[DIR+8*ss];							\ | ||||
|   ptype=st_perm[DIR];							\ | ||||
|  /*SE=st.GetEntry(ptype,DIR,ss);*/					\ | ||||
|   offset = SE->_offset;				\ | ||||
|   perm   = SE->_permute;			\ | ||||
|   LOAD_CHIMU(PERM);				\ | ||||
|   PROJ;						\ | ||||
|   MULT_2SPIN(DIR);				\ | ||||
|   RECON;					 | ||||
|  | ||||
| @@ -424,7 +376,7 @@ Author: paboyle <paboyle@ph.ed.ac.uk> | ||||
|   local  = SE->_is_local;			\ | ||||
|   perm   = SE->_permute;			\ | ||||
|   if ( local ) {				\ | ||||
|     LOAD_CHIMU(PERM);				\ | ||||
|     LOAD_CHIMU;					\ | ||||
|     PROJ;					\ | ||||
|     if ( perm) {				\ | ||||
|       PERMUTE_DIR(PERM);			\ | ||||
| @@ -432,12 +384,10 @@ Author: paboyle <paboyle@ph.ed.ac.uk> | ||||
|   } else if ( st.same_node[DIR] ) {		\ | ||||
|     LOAD_CHI;					\ | ||||
|   }						\ | ||||
|   acceleratorSynchronise();			\ | ||||
|   if (local || st.same_node[DIR] ) {		\ | ||||
|     MULT_2SPIN(DIR);				\ | ||||
|     RECON;					\ | ||||
|   }						\ | ||||
|   acceleratorSynchronise();			 | ||||
|   } | ||||
|  | ||||
| #define HAND_STENCIL_LEG_EXT(PROJ,PERM,DIR,RECON)	\ | ||||
|   SE=st.GetEntry(ptype,DIR,ss);			\ | ||||
| @@ -447,44 +397,44 @@ Author: paboyle <paboyle@ph.ed.ac.uk> | ||||
|     MULT_2SPIN(DIR);				\ | ||||
|     RECON;					\ | ||||
|     nmu++;					\ | ||||
|   }						\ | ||||
|   acceleratorSynchronise();			 | ||||
|   } | ||||
|  | ||||
| #define HAND_RESULT(ss)				\ | ||||
|   {						\ | ||||
|     SiteSpinor & ref (out[ss]);		\ | ||||
|     coalescedWrite(ref()(0)(0),result_00,lane);		\ | ||||
|     coalescedWrite(ref()(0)(1),result_01,lane);		\ | ||||
|     coalescedWrite(ref()(0)(2),result_02,lane);		\ | ||||
|     coalescedWrite(ref()(1)(0),result_10,lane);		\ | ||||
|     coalescedWrite(ref()(1)(1),result_11,lane);		\ | ||||
|     coalescedWrite(ref()(1)(2),result_12,lane);		\ | ||||
|     coalescedWrite(ref()(2)(0),result_20,lane);		\ | ||||
|     coalescedWrite(ref()(2)(1),result_21,lane);		\ | ||||
|     coalescedWrite(ref()(2)(2),result_22,lane);		\ | ||||
|     coalescedWrite(ref()(3)(0),result_30,lane);		\ | ||||
|     coalescedWrite(ref()(3)(1),result_31,lane);		\ | ||||
|     coalescedWrite(ref()(3)(2),result_32,lane);		\ | ||||
|     vstream(ref()(0)(0),result_00);		\ | ||||
|     vstream(ref()(0)(1),result_01);		\ | ||||
|     vstream(ref()(0)(2),result_02);		\ | ||||
|     vstream(ref()(1)(0),result_10);		\ | ||||
|     vstream(ref()(1)(1),result_11);		\ | ||||
|     vstream(ref()(1)(2),result_12);		\ | ||||
|     vstream(ref()(2)(0),result_20);		\ | ||||
|     vstream(ref()(2)(1),result_21);		\ | ||||
|     vstream(ref()(2)(2),result_22);		\ | ||||
|     vstream(ref()(3)(0),result_30);		\ | ||||
|     vstream(ref()(3)(1),result_31);		\ | ||||
|     vstream(ref()(3)(2),result_32);		\ | ||||
|   } | ||||
|  | ||||
| #define HAND_RESULT_EXT(ss)			\ | ||||
|   {							\ | ||||
|   if (nmu){					\ | ||||
|     SiteSpinor & ref (out[ss]);		\ | ||||
|     coalescedWrite(ref()(0)(0),coalescedRead(ref()(0)(0))+result_00,lane);	\ | ||||
|     coalescedWrite(ref()(0)(1),coalescedRead(ref()(0)(1))+result_01,lane);	\ | ||||
|     coalescedWrite(ref()(0)(2),coalescedRead(ref()(0)(2))+result_02,lane);	\ | ||||
|     coalescedWrite(ref()(1)(0),coalescedRead(ref()(1)(0))+result_10,lane);	\ | ||||
|     coalescedWrite(ref()(1)(1),coalescedRead(ref()(1)(1))+result_11,lane);	\ | ||||
|     coalescedWrite(ref()(1)(2),coalescedRead(ref()(1)(2))+result_12,lane);	\ | ||||
|     coalescedWrite(ref()(2)(0),coalescedRead(ref()(2)(0))+result_20,lane);	\ | ||||
|     coalescedWrite(ref()(2)(1),coalescedRead(ref()(2)(1))+result_21,lane);	\ | ||||
|     coalescedWrite(ref()(2)(2),coalescedRead(ref()(2)(2))+result_22,lane);	\ | ||||
|     coalescedWrite(ref()(3)(0),coalescedRead(ref()(3)(0))+result_30,lane);	\ | ||||
|     coalescedWrite(ref()(3)(1),coalescedRead(ref()(3)(1))+result_31,lane);	\ | ||||
|     coalescedWrite(ref()(3)(2),coalescedRead(ref()(3)(2))+result_32,lane);	\ | ||||
|     ref()(0)(0)+=result_00;		\ | ||||
|     ref()(0)(1)+=result_01;		\ | ||||
|     ref()(0)(2)+=result_02;		\ | ||||
|     ref()(1)(0)+=result_10;		\ | ||||
|     ref()(1)(1)+=result_11;		\ | ||||
|     ref()(1)(2)+=result_12;		\ | ||||
|     ref()(2)(0)+=result_20;		\ | ||||
|     ref()(2)(1)+=result_21;		\ | ||||
|     ref()(2)(2)+=result_22;		\ | ||||
|     ref()(3)(0)+=result_30;		\ | ||||
|     ref()(3)(1)+=result_31;		\ | ||||
|     ref()(3)(2)+=result_32;		\ | ||||
|   } | ||||
|  | ||||
| #define HAND_DECLARATIONS(Simd)			\ | ||||
|  | ||||
| #define HAND_DECLARATIONS(a)			\ | ||||
|   Simd result_00;				\ | ||||
|   Simd result_01;				\ | ||||
|   Simd result_02;				\ | ||||
| @@ -517,18 +467,18 @@ Author: paboyle <paboyle@ph.ed.ac.uk> | ||||
|   Simd U_21; | ||||
|  | ||||
| #define ZERO_RESULT				\ | ||||
|   zeroit(result_00);							\ | ||||
|   zeroit(result_01);							\ | ||||
|   zeroit(result_02);							\ | ||||
|   zeroit(result_10);							\ | ||||
|   zeroit(result_11);							\ | ||||
|   zeroit(result_12);							\ | ||||
|   zeroit(result_20);							\ | ||||
|   zeroit(result_21);							\ | ||||
|   zeroit(result_22);							\ | ||||
|   zeroit(result_30);							\ | ||||
|   zeroit(result_31);							\ | ||||
|   zeroit(result_32);			 | ||||
|   result_00=Zero();				\ | ||||
|   result_01=Zero();				\ | ||||
|   result_02=Zero();				\ | ||||
|   result_10=Zero();				\ | ||||
|   result_11=Zero();				\ | ||||
|   result_12=Zero();				\ | ||||
|   result_20=Zero();				\ | ||||
|   result_21=Zero();				\ | ||||
|   result_22=Zero();				\ | ||||
|   result_30=Zero();				\ | ||||
|   result_31=Zero();				\ | ||||
|   result_32=Zero();			 | ||||
|  | ||||
| #define Chimu_00 Chi_00 | ||||
| #define Chimu_01 Chi_01 | ||||
| @@ -545,53 +495,15 @@ Author: paboyle <paboyle@ph.ed.ac.uk> | ||||
|  | ||||
| NAMESPACE_BEGIN(Grid); | ||||
|  | ||||
|  | ||||
| #ifdef SYCL_HACK | ||||
| template<class Impl> accelerator_inline void  | ||||
| WilsonKernels<Impl>::HandDhopSiteSycl(StencilVector st_perm,StencilEntry *st_p, SiteDoubledGaugeField *U,SiteHalfSpinor  *buf, | ||||
| 				      int ss,int sU,const SiteSpinor *in, SiteSpinor *out) | ||||
| WilsonKernels<Impl>::HandDhopSite(const StencilView &st, const DoubledGaugeFieldView &U,SiteHalfSpinor  *buf, | ||||
| 				  int ss,int sU,const FermionFieldView &in, const FermionFieldView &out) | ||||
| { | ||||
| // T==0, Z==1, Y==2, Z==3 expect 1,2,2,2 simd layout etc... | ||||
|   typedef typename Simd::scalar_type S; | ||||
|   typedef typename Simd::vector_type V; | ||||
|   typedef iSinglet<Simd> vCplx; | ||||
|   //  typedef decltype( coalescedRead( vCplx()()() )) Simt; | ||||
|   typedef decltype( coalescedRead( in[0]()(0)(0) )) Simt; | ||||
|  | ||||
|   const int Nsimd = SiteHalfSpinor::Nsimd(); | ||||
|   const int lane=acceleratorSIMTlane(Nsimd); | ||||
|  | ||||
|   HAND_DECLARATIONS(Simt); | ||||
|  | ||||
|   int offset,local,perm, ptype; | ||||
|   StencilEntry *SE; | ||||
|   HAND_STENCIL_LEG(XM_PROJ,3,Xp,XM_RECON); | ||||
|   HAND_STENCIL_LEG(YM_PROJ,2,Yp,YM_RECON_ACCUM); | ||||
|   HAND_STENCIL_LEG(ZM_PROJ,1,Zp,ZM_RECON_ACCUM); | ||||
|   HAND_STENCIL_LEG(TM_PROJ,0,Tp,TM_RECON_ACCUM); | ||||
|   HAND_STENCIL_LEG(XP_PROJ,3,Xm,XP_RECON_ACCUM); | ||||
|   HAND_STENCIL_LEG(YP_PROJ,2,Ym,YP_RECON_ACCUM); | ||||
|   HAND_STENCIL_LEG(ZP_PROJ,1,Zm,ZP_RECON_ACCUM); | ||||
|   HAND_STENCIL_LEG(TP_PROJ,0,Tm,TP_RECON_ACCUM); | ||||
|   HAND_RESULT(ss); | ||||
| } | ||||
| #endif | ||||
|  | ||||
| template<class Impl> accelerator_inline void  | ||||
| WilsonKernels<Impl>::HandDhopSite(StencilView &st, DoubledGaugeFieldView &U,SiteHalfSpinor  *buf, | ||||
| 				  int ss,int sU,const FermionFieldView &in, FermionFieldView &out) | ||||
| { | ||||
|   auto st_p = st._entries_p;						 | ||||
|   auto st_perm = st._permute_type;					 | ||||
| // T==0, Z==1, Y==2, Z==3 expect 1,2,2,2 simd layout etc... | ||||
|   typedef typename Simd::scalar_type S; | ||||
|   typedef typename Simd::vector_type V; | ||||
|   typedef decltype( coalescedRead( in[0]()(0)(0) )) Simt; | ||||
|  | ||||
|   const int Nsimd = SiteHalfSpinor::Nsimd(); | ||||
|   const int lane=acceleratorSIMTlane(Nsimd); | ||||
|  | ||||
|   HAND_DECLARATIONS(Simt); | ||||
|   HAND_DECLARATIONS(ignore); | ||||
|  | ||||
|   int offset,local,perm, ptype; | ||||
|   StencilEntry *SE; | ||||
| @@ -608,19 +520,13 @@ WilsonKernels<Impl>::HandDhopSite(StencilView &st, DoubledGaugeFieldView &U,Site | ||||
| } | ||||
|  | ||||
| template<class Impl>  accelerator_inline | ||||
| void WilsonKernels<Impl>::HandDhopSiteDag(StencilView &st,DoubledGaugeFieldView &U,SiteHalfSpinor *buf, | ||||
| 					  int ss,int sU,const FermionFieldView &in, FermionFieldView &out) | ||||
| void WilsonKernels<Impl>::HandDhopSiteDag(const StencilView &st,const DoubledGaugeFieldView &U,SiteHalfSpinor *buf, | ||||
| 					  int ss,int sU,const FermionFieldView &in, const FermionFieldView &out) | ||||
| { | ||||
|   auto st_p = st._entries_p;						 | ||||
|   auto st_perm = st._permute_type;					 | ||||
|   typedef typename Simd::scalar_type S; | ||||
|   typedef typename Simd::vector_type V; | ||||
|   typedef decltype( coalescedRead( in[0]()(0)(0) )) Simt; | ||||
|  | ||||
|   const int Nsimd = SiteHalfSpinor::Nsimd(); | ||||
|   const int lane=acceleratorSIMTlane(Nsimd); | ||||
|  | ||||
|   HAND_DECLARATIONS(Simt); | ||||
|   HAND_DECLARATIONS(ignore); | ||||
|  | ||||
|   StencilEntry *SE; | ||||
|   int offset,local,perm, ptype; | ||||
| @@ -637,20 +543,14 @@ void WilsonKernels<Impl>::HandDhopSiteDag(StencilView &st,DoubledGaugeFieldView | ||||
| } | ||||
|  | ||||
| template<class Impl>  accelerator_inline void  | ||||
| WilsonKernels<Impl>::HandDhopSiteInt(StencilView &st,DoubledGaugeFieldView &U,SiteHalfSpinor  *buf, | ||||
| 					  int ss,int sU,const FermionFieldView &in, FermionFieldView &out) | ||||
| WilsonKernels<Impl>::HandDhopSiteInt(const StencilView &st,const DoubledGaugeFieldView &U,SiteHalfSpinor  *buf, | ||||
| 					  int ss,int sU,const FermionFieldView &in, const FermionFieldView &out) | ||||
| { | ||||
|   auto st_p = st._entries_p;						 | ||||
|   auto st_perm = st._permute_type;					 | ||||
| // T==0, Z==1, Y==2, Z==3 expect 1,2,2,2 simd layout etc... | ||||
|   typedef typename Simd::scalar_type S; | ||||
|   typedef typename Simd::vector_type V; | ||||
|   typedef decltype( coalescedRead( in[0]()(0)(0) )) Simt; | ||||
|  | ||||
|   const int Nsimd = SiteHalfSpinor::Nsimd(); | ||||
|   const int lane=acceleratorSIMTlane(Nsimd); | ||||
|  | ||||
|   HAND_DECLARATIONS(Simt); | ||||
|   HAND_DECLARATIONS(ignore); | ||||
|  | ||||
|   int offset,local,perm, ptype; | ||||
|   StencilEntry *SE; | ||||
| @@ -667,19 +567,13 @@ WilsonKernels<Impl>::HandDhopSiteInt(StencilView &st,DoubledGaugeFieldView &U,Si | ||||
| } | ||||
|  | ||||
| template<class Impl> accelerator_inline | ||||
| void WilsonKernels<Impl>::HandDhopSiteDagInt(StencilView &st,DoubledGaugeFieldView &U,SiteHalfSpinor *buf, | ||||
| 						  int ss,int sU,const FermionFieldView &in, FermionFieldView &out) | ||||
| void WilsonKernels<Impl>::HandDhopSiteDagInt(const StencilView &st,const DoubledGaugeFieldView &U,SiteHalfSpinor *buf, | ||||
| 						  int ss,int sU,const FermionFieldView &in, const FermionFieldView &out) | ||||
| { | ||||
|   auto st_p = st._entries_p;						 | ||||
|   auto st_perm = st._permute_type;					 | ||||
|   typedef typename Simd::scalar_type S; | ||||
|   typedef typename Simd::vector_type V; | ||||
|   typedef decltype( coalescedRead( in[0]()(0)(0) )) Simt; | ||||
|  | ||||
|   const int Nsimd = SiteHalfSpinor::Nsimd(); | ||||
|   const int lane=acceleratorSIMTlane(Nsimd); | ||||
|  | ||||
|   HAND_DECLARATIONS(Simt); | ||||
|   HAND_DECLARATIONS(ignore); | ||||
|  | ||||
|   StencilEntry *SE; | ||||
|   int offset,local,perm, ptype; | ||||
| @@ -696,20 +590,14 @@ void WilsonKernels<Impl>::HandDhopSiteDagInt(StencilView &st,DoubledGaugeFieldVi | ||||
| } | ||||
|  | ||||
| template<class Impl>  accelerator_inline void  | ||||
| WilsonKernels<Impl>::HandDhopSiteExt(StencilView &st,DoubledGaugeFieldView &U,SiteHalfSpinor  *buf, | ||||
| 					  int ss,int sU,const FermionFieldView &in, FermionFieldView &out) | ||||
| WilsonKernels<Impl>::HandDhopSiteExt(const StencilView &st,const DoubledGaugeFieldView &U,SiteHalfSpinor  *buf, | ||||
| 					  int ss,int sU,const FermionFieldView &in, const FermionFieldView &out) | ||||
| { | ||||
|   auto st_p = st._entries_p;						 | ||||
|   auto st_perm = st._permute_type;					 | ||||
| // T==0, Z==1, Y==2, Z==3 expect 1,2,2,2 simd layout etc... | ||||
|   typedef typename Simd::scalar_type S; | ||||
|   typedef typename Simd::vector_type V; | ||||
|   typedef decltype( coalescedRead( in[0]()(0)(0) )) Simt; | ||||
|  | ||||
|   const int Nsimd = SiteHalfSpinor::Nsimd(); | ||||
|   const int lane=acceleratorSIMTlane(Nsimd); | ||||
|  | ||||
|   HAND_DECLARATIONS(Simt); | ||||
|   HAND_DECLARATIONS(ignore); | ||||
|  | ||||
|   int offset, ptype; | ||||
|   StencilEntry *SE; | ||||
| @@ -727,19 +615,13 @@ WilsonKernels<Impl>::HandDhopSiteExt(StencilView &st,DoubledGaugeFieldView &U,Si | ||||
| } | ||||
|  | ||||
| template<class Impl>  accelerator_inline | ||||
| void WilsonKernels<Impl>::HandDhopSiteDagExt(StencilView &st,DoubledGaugeFieldView &U,SiteHalfSpinor *buf, | ||||
| 						  int ss,int sU,const FermionFieldView &in, FermionFieldView &out) | ||||
| void WilsonKernels<Impl>::HandDhopSiteDagExt(const StencilView &st,const DoubledGaugeFieldView &U,SiteHalfSpinor *buf, | ||||
| 						  int ss,int sU,const FermionFieldView &in, const FermionFieldView &out) | ||||
| { | ||||
|   auto st_p = st._entries_p;						 | ||||
|   auto st_perm = st._permute_type;					 | ||||
|   typedef typename Simd::scalar_type S; | ||||
|   typedef typename Simd::vector_type V; | ||||
|   typedef decltype( coalescedRead( in[0]()(0)(0) )) Simt; | ||||
|  | ||||
|   const int Nsimd = SiteHalfSpinor::Nsimd(); | ||||
|   const int lane=acceleratorSIMTlane(Nsimd); | ||||
|  | ||||
|   HAND_DECLARATIONS(Simt); | ||||
|   HAND_DECLARATIONS(ignore); | ||||
|  | ||||
|   StencilEntry *SE; | ||||
|   int offset, ptype; | ||||
|   | ||||
| @@ -0,0 +1,598 @@ | ||||
|    /************************************************************************************* | ||||
|  | ||||
|     Grid physics library, www.github.com/paboyle/Grid  | ||||
|  | ||||
|     Source file: ./lib/qcd/action/fermion/WilsonKernelsHand.cc | ||||
|  | ||||
|     Copyright (C) 2015 | ||||
|  | ||||
| Author: Peter Boyle <paboyle@ph.ed.ac.uk> | ||||
| Author: paboyle <paboyle@ph.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 | ||||
|     the Free Software Foundation; either version 2 of the License, or | ||||
|     (at your option) any later version. | ||||
|  | ||||
|     This program is distributed in the hope that it will be useful, | ||||
|     but WITHOUT ANY WARRANTY; without even the implied warranty of | ||||
|     MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE.  See the | ||||
|     GNU General Public License for more details. | ||||
|  | ||||
|     You should have received a copy of the GNU General Public License along | ||||
|     with this program; if not, write to the Free Software Foundation, Inc., | ||||
|     51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. | ||||
|  | ||||
|     See the full license in the file "LICENSE" in the top level distribution directory | ||||
|     *************************************************************************************/ | ||||
|     /*  END LEGAL */ | ||||
|  | ||||
| #pragma once | ||||
|  | ||||
| #include <Grid/qcd/action/fermion/FermionCore.h> | ||||
|  | ||||
|  | ||||
| #undef LOAD_CHIMU   | ||||
| #undef LOAD_CHI  | ||||
| #undef MULT_2SPIN | ||||
| #undef PERMUTE_DIR | ||||
| #undef XP_PROJ   | ||||
| #undef YP_PROJ   | ||||
| #undef ZP_PROJ   | ||||
| #undef TP_PROJ   | ||||
| #undef XM_PROJ   | ||||
| #undef YM_PROJ   | ||||
| #undef ZM_PROJ   | ||||
| #undef TM_PROJ   | ||||
| #undef XP_RECON  | ||||
| #undef XP_RECON_ACCUM  | ||||
| #undef XM_RECON  | ||||
| #undef XM_RECON_ACCUM  | ||||
| #undef YP_RECON_ACCUM  | ||||
| #undef YM_RECON_ACCUM  | ||||
| #undef ZP_RECON_ACCUM  | ||||
| #undef ZM_RECON_ACCUM  | ||||
| #undef TP_RECON_ACCUM  | ||||
| #undef TM_RECON_ACCUM  | ||||
| #undef ZERO_RESULT				  | ||||
| #undef Chimu_00 | ||||
| #undef Chimu_01 | ||||
| #undef Chimu_02 | ||||
| #undef Chimu_10 | ||||
| #undef Chimu_11 | ||||
| #undef Chimu_12 | ||||
| #undef Chimu_20 | ||||
| #undef Chimu_21 | ||||
| #undef Chimu_22 | ||||
| #undef Chimu_30 | ||||
| #undef Chimu_31 | ||||
| #undef Chimu_32 | ||||
| #undef HAND_STENCIL_LEG | ||||
| #undef HAND_STENCIL_LEG_INT | ||||
| #undef HAND_STENCIL_LEG_EXT | ||||
| #undef HAND_RESULT | ||||
| #undef HAND_RESULT_INT | ||||
| #undef HAND_RESULT_EXT | ||||
|  | ||||
| #define REGISTER | ||||
|  | ||||
| #ifdef GRID_SIMT | ||||
| #define LOAD_CHIMU(ptype)		\ | ||||
|   {const SiteSpinor & ref (in[offset]);	\ | ||||
|     Chimu_00=coalescedReadPermute<ptype>(ref()(0)(0),perm);	\ | ||||
|     Chimu_01=coalescedReadPermute<ptype>(ref()(0)(1),perm);	\ | ||||
|     Chimu_02=coalescedReadPermute<ptype>(ref()(0)(2),perm);	\ | ||||
|     Chimu_10=coalescedReadPermute<ptype>(ref()(1)(0),perm);	\ | ||||
|     Chimu_11=coalescedReadPermute<ptype>(ref()(1)(1),perm);	\ | ||||
|     Chimu_12=coalescedReadPermute<ptype>(ref()(1)(2),perm);	\ | ||||
|     Chimu_20=coalescedReadPermute<ptype>(ref()(2)(0),perm);	\ | ||||
|     Chimu_21=coalescedReadPermute<ptype>(ref()(2)(1),perm);	\ | ||||
|     Chimu_22=coalescedReadPermute<ptype>(ref()(2)(2),perm);	\ | ||||
|     Chimu_30=coalescedReadPermute<ptype>(ref()(3)(0),perm);	\ | ||||
|     Chimu_31=coalescedReadPermute<ptype>(ref()(3)(1),perm);	\ | ||||
|     Chimu_32=coalescedReadPermute<ptype>(ref()(3)(2),perm);	} | ||||
|  | ||||
| #define PERMUTE_DIR(dir) ; | ||||
| #else | ||||
| #define LOAD_CHIMU(ptype)		\ | ||||
|   {const SiteSpinor & ref (in[offset]);	\ | ||||
|     Chimu_00=coalescedRead(ref()(0)(0));	\ | ||||
|     Chimu_01=coalescedRead(ref()(0)(1));	\ | ||||
|     Chimu_02=coalescedRead(ref()(0)(2));	\ | ||||
|     Chimu_10=coalescedRead(ref()(1)(0));	\ | ||||
|     Chimu_11=coalescedRead(ref()(1)(1));	\ | ||||
|     Chimu_12=coalescedRead(ref()(1)(2));	\ | ||||
|     Chimu_20=coalescedRead(ref()(2)(0));	\ | ||||
|     Chimu_21=coalescedRead(ref()(2)(1));	\ | ||||
|     Chimu_22=coalescedRead(ref()(2)(2));	\ | ||||
|     Chimu_30=coalescedRead(ref()(3)(0));	\ | ||||
|     Chimu_31=coalescedRead(ref()(3)(1));	\ | ||||
|     Chimu_32=coalescedRead(ref()(3)(2));	} | ||||
|  | ||||
| #define PERMUTE_DIR(dir)			\ | ||||
|   permute##dir(Chi_00,Chi_00);	\ | ||||
|       permute##dir(Chi_01,Chi_01);\ | ||||
|       permute##dir(Chi_02,Chi_02);\ | ||||
|       permute##dir(Chi_10,Chi_10);	\ | ||||
|       permute##dir(Chi_11,Chi_11);\ | ||||
|       permute##dir(Chi_12,Chi_12); | ||||
| #endif | ||||
|  | ||||
| #define MULT_2SPIN(A)\ | ||||
|   {auto & ref(U[sU](A));					\ | ||||
|   U_00=coalescedRead(ref()(0,0));				\ | ||||
|   U_10=coalescedRead(ref()(1,0));					\ | ||||
|   U_20=coalescedRead(ref()(2,0));					\ | ||||
|   U_01=coalescedRead(ref()(0,1));					\ | ||||
|   U_11=coalescedRead(ref()(1,1));					\ | ||||
|   U_21=coalescedRead(ref()(2,1));					\ | ||||
|     UChi_00 = U_00*Chi_00;					\ | ||||
|     UChi_10 = U_00*Chi_10;					\ | ||||
|     UChi_01 = U_10*Chi_00;					\ | ||||
|     UChi_11 = U_10*Chi_10;					\ | ||||
|     UChi_02 = U_20*Chi_00;					\ | ||||
|     UChi_12 = U_20*Chi_10;					\ | ||||
|     UChi_00+= U_01*Chi_01;					\ | ||||
|     UChi_10+= U_01*Chi_11;					\ | ||||
|     UChi_01+= U_11*Chi_01;					\ | ||||
|     UChi_11+= U_11*Chi_11;					\ | ||||
|     UChi_02+= U_21*Chi_01;					\ | ||||
|     UChi_12+= U_21*Chi_11;					\ | ||||
|     U_00=coalescedRead(ref()(0,2));				\ | ||||
|     U_10=coalescedRead(ref()(1,2));				\ | ||||
|     U_20=coalescedRead(ref()(2,2));				\ | ||||
|     UChi_00+= U_00*Chi_02;					\ | ||||
|     UChi_10+= U_00*Chi_12;					\ | ||||
|     UChi_01+= U_10*Chi_02;					\ | ||||
|     UChi_11+= U_10*Chi_12;					\ | ||||
|     UChi_02+= U_20*Chi_02;					\ | ||||
|     UChi_12+= U_20*Chi_12;} | ||||
|  | ||||
| #define LOAD_CHI				\ | ||||
|   {const SiteHalfSpinor &ref(buf[offset]);	\ | ||||
|     Chi_00 = coalescedRead(ref()(0)(0));	\ | ||||
|     Chi_01 = coalescedRead(ref()(0)(1));	\ | ||||
|     Chi_02 = coalescedRead(ref()(0)(2));	\ | ||||
|     Chi_10 = coalescedRead(ref()(1)(0));	\ | ||||
|     Chi_11 = coalescedRead(ref()(1)(1));	\ | ||||
|     Chi_12 = coalescedRead(ref()(1)(2));} | ||||
|  | ||||
| //      hspin(0)=fspin(0)+timesI(fspin(3)); | ||||
| //      hspin(1)=fspin(1)+timesI(fspin(2)); | ||||
| #define XP_PROJ \ | ||||
|     Chi_00 = Chimu_00+timesI(Chimu_30);\ | ||||
|     Chi_01 = Chimu_01+timesI(Chimu_31);\ | ||||
|     Chi_02 = Chimu_02+timesI(Chimu_32);\ | ||||
|     Chi_10 = Chimu_10+timesI(Chimu_20);\ | ||||
|     Chi_11 = Chimu_11+timesI(Chimu_21);\ | ||||
|     Chi_12 = Chimu_12+timesI(Chimu_22); | ||||
|  | ||||
| #define YP_PROJ \ | ||||
|     Chi_00 = Chimu_00-Chimu_30;\ | ||||
|     Chi_01 = Chimu_01-Chimu_31;\ | ||||
|     Chi_02 = Chimu_02-Chimu_32;\ | ||||
|     Chi_10 = Chimu_10+Chimu_20;\ | ||||
|     Chi_11 = Chimu_11+Chimu_21;\ | ||||
|     Chi_12 = Chimu_12+Chimu_22; | ||||
|  | ||||
| #define ZP_PROJ \ | ||||
|   Chi_00 = Chimu_00+timesI(Chimu_20);		\ | ||||
|   Chi_01 = Chimu_01+timesI(Chimu_21);		\ | ||||
|   Chi_02 = Chimu_02+timesI(Chimu_22);		\ | ||||
|   Chi_10 = Chimu_10-timesI(Chimu_30);		\ | ||||
|   Chi_11 = Chimu_11-timesI(Chimu_31);		\ | ||||
|   Chi_12 = Chimu_12-timesI(Chimu_32); | ||||
|  | ||||
| #define TP_PROJ \ | ||||
|   Chi_00 = Chimu_00+Chimu_20;		\ | ||||
|   Chi_01 = Chimu_01+Chimu_21;		\ | ||||
|   Chi_02 = Chimu_02+Chimu_22;		\ | ||||
|   Chi_10 = Chimu_10+Chimu_30;		\ | ||||
|   Chi_11 = Chimu_11+Chimu_31;		\ | ||||
|   Chi_12 = Chimu_12+Chimu_32; | ||||
|  | ||||
|  | ||||
| //      hspin(0)=fspin(0)-timesI(fspin(3)); | ||||
| //      hspin(1)=fspin(1)-timesI(fspin(2)); | ||||
| #define XM_PROJ \ | ||||
|     Chi_00 = Chimu_00-timesI(Chimu_30);\ | ||||
|     Chi_01 = Chimu_01-timesI(Chimu_31);\ | ||||
|     Chi_02 = Chimu_02-timesI(Chimu_32);\ | ||||
|     Chi_10 = Chimu_10-timesI(Chimu_20);\ | ||||
|     Chi_11 = Chimu_11-timesI(Chimu_21);\ | ||||
|     Chi_12 = Chimu_12-timesI(Chimu_22); | ||||
|  | ||||
| #define YM_PROJ \ | ||||
|     Chi_00 = Chimu_00+Chimu_30;\ | ||||
|     Chi_01 = Chimu_01+Chimu_31;\ | ||||
|     Chi_02 = Chimu_02+Chimu_32;\ | ||||
|     Chi_10 = Chimu_10-Chimu_20;\ | ||||
|     Chi_11 = Chimu_11-Chimu_21;\ | ||||
|     Chi_12 = Chimu_12-Chimu_22; | ||||
|  | ||||
| #define ZM_PROJ \ | ||||
|   Chi_00 = Chimu_00-timesI(Chimu_20);		\ | ||||
|   Chi_01 = Chimu_01-timesI(Chimu_21);		\ | ||||
|   Chi_02 = Chimu_02-timesI(Chimu_22);		\ | ||||
|   Chi_10 = Chimu_10+timesI(Chimu_30);		\ | ||||
|   Chi_11 = Chimu_11+timesI(Chimu_31);		\ | ||||
|   Chi_12 = Chimu_12+timesI(Chimu_32); | ||||
|  | ||||
| #define TM_PROJ \ | ||||
|   Chi_00 = Chimu_00-Chimu_20;		\ | ||||
|   Chi_01 = Chimu_01-Chimu_21;		\ | ||||
|   Chi_02 = Chimu_02-Chimu_22;		\ | ||||
|   Chi_10 = Chimu_10-Chimu_30;		\ | ||||
|   Chi_11 = Chimu_11-Chimu_31;		\ | ||||
|   Chi_12 = Chimu_12-Chimu_32; | ||||
|  | ||||
| //      fspin(0)=hspin(0); | ||||
| //      fspin(1)=hspin(1); | ||||
| //      fspin(2)=timesMinusI(hspin(1)); | ||||
| //      fspin(3)=timesMinusI(hspin(0)); | ||||
| #define XP_RECON\ | ||||
|   result_00 = UChi_00;\ | ||||
|   result_01 = UChi_01;\ | ||||
|   result_02 = UChi_02;\ | ||||
|   result_10 = UChi_10;\ | ||||
|   result_11 = UChi_11;\ | ||||
|   result_12 = UChi_12;\ | ||||
|   result_20 = timesMinusI(UChi_10);\ | ||||
|   result_21 = timesMinusI(UChi_11);\ | ||||
|   result_22 = timesMinusI(UChi_12);\ | ||||
|   result_30 = timesMinusI(UChi_00);\ | ||||
|   result_31 = timesMinusI(UChi_01);\ | ||||
|   result_32 = timesMinusI(UChi_02); | ||||
|  | ||||
| #define XP_RECON_ACCUM\ | ||||
|   result_00+=UChi_00;\ | ||||
|   result_01+=UChi_01;\ | ||||
|   result_02+=UChi_02;\ | ||||
|   result_10+=UChi_10;\ | ||||
|   result_11+=UChi_11;\ | ||||
|   result_12+=UChi_12;\ | ||||
|   result_20-=timesI(UChi_10);\ | ||||
|   result_21-=timesI(UChi_11);\ | ||||
|   result_22-=timesI(UChi_12);\ | ||||
|   result_30-=timesI(UChi_00);\ | ||||
|   result_31-=timesI(UChi_01);\ | ||||
|   result_32-=timesI(UChi_02); | ||||
|  | ||||
| #define XM_RECON\ | ||||
|   result_00 = UChi_00;\ | ||||
|   result_01 = UChi_01;\ | ||||
|   result_02 = UChi_02;\ | ||||
|   result_10 = UChi_10;\ | ||||
|   result_11 = UChi_11;\ | ||||
|   result_12 = UChi_12;\ | ||||
|   result_20 = timesI(UChi_10);\ | ||||
|   result_21 = timesI(UChi_11);\ | ||||
|   result_22 = timesI(UChi_12);\ | ||||
|   result_30 = timesI(UChi_00);\ | ||||
|   result_31 = timesI(UChi_01);\ | ||||
|   result_32 = timesI(UChi_02); | ||||
|  | ||||
| #define XM_RECON_ACCUM\ | ||||
|   result_00+= UChi_00;\ | ||||
|   result_01+= UChi_01;\ | ||||
|   result_02+= UChi_02;\ | ||||
|   result_10+= UChi_10;\ | ||||
|   result_11+= UChi_11;\ | ||||
|   result_12+= UChi_12;\ | ||||
|   result_20+= timesI(UChi_10);\ | ||||
|   result_21+= timesI(UChi_11);\ | ||||
|   result_22+= timesI(UChi_12);\ | ||||
|   result_30+= timesI(UChi_00);\ | ||||
|   result_31+= timesI(UChi_01);\ | ||||
|   result_32+= timesI(UChi_02); | ||||
|  | ||||
| #define YP_RECON_ACCUM\ | ||||
|   result_00+= UChi_00;\ | ||||
|   result_01+= UChi_01;\ | ||||
|   result_02+= UChi_02;\ | ||||
|   result_10+= UChi_10;\ | ||||
|   result_11+= UChi_11;\ | ||||
|   result_12+= UChi_12;\ | ||||
|   result_20+= UChi_10;\ | ||||
|   result_21+= UChi_11;\ | ||||
|   result_22+= UChi_12;\ | ||||
|   result_30-= UChi_00;\ | ||||
|   result_31-= UChi_01;\ | ||||
|   result_32-= UChi_02; | ||||
|  | ||||
| #define YM_RECON_ACCUM\ | ||||
|   result_00+= UChi_00;\ | ||||
|   result_01+= UChi_01;\ | ||||
|   result_02+= UChi_02;\ | ||||
|   result_10+= UChi_10;\ | ||||
|   result_11+= UChi_11;\ | ||||
|   result_12+= UChi_12;\ | ||||
|   result_20-= UChi_10;\ | ||||
|   result_21-= UChi_11;\ | ||||
|   result_22-= UChi_12;\ | ||||
|   result_30+= UChi_00;\ | ||||
|   result_31+= UChi_01;\ | ||||
|   result_32+= UChi_02; | ||||
|  | ||||
| #define ZP_RECON_ACCUM\ | ||||
|   result_00+= UChi_00;\ | ||||
|   result_01+= UChi_01;\ | ||||
|   result_02+= UChi_02;\ | ||||
|   result_10+= UChi_10;\ | ||||
|   result_11+= UChi_11;\ | ||||
|   result_12+= UChi_12;\ | ||||
|   result_20-= timesI(UChi_00);			\ | ||||
|   result_21-= timesI(UChi_01);			\ | ||||
|   result_22-= timesI(UChi_02);			\ | ||||
|   result_30+= timesI(UChi_10);			\ | ||||
|   result_31+= timesI(UChi_11);			\ | ||||
|   result_32+= timesI(UChi_12); | ||||
|  | ||||
| #define ZM_RECON_ACCUM\ | ||||
|   result_00+= UChi_00;\ | ||||
|   result_01+= UChi_01;\ | ||||
|   result_02+= UChi_02;\ | ||||
|   result_10+= UChi_10;\ | ||||
|   result_11+= UChi_11;\ | ||||
|   result_12+= UChi_12;\ | ||||
|   result_20+= timesI(UChi_00);			\ | ||||
|   result_21+= timesI(UChi_01);			\ | ||||
|   result_22+= timesI(UChi_02);			\ | ||||
|   result_30-= timesI(UChi_10);			\ | ||||
|   result_31-= timesI(UChi_11);			\ | ||||
|   result_32-= timesI(UChi_12); | ||||
|  | ||||
| #define TP_RECON_ACCUM\ | ||||
|   result_00+= UChi_00;\ | ||||
|   result_01+= UChi_01;\ | ||||
|   result_02+= UChi_02;\ | ||||
|   result_10+= UChi_10;\ | ||||
|   result_11+= UChi_11;\ | ||||
|   result_12+= UChi_12;\ | ||||
|   result_20+= UChi_00;			\ | ||||
|   result_21+= UChi_01;			\ | ||||
|   result_22+= UChi_02;			\ | ||||
|   result_30+= UChi_10;			\ | ||||
|   result_31+= UChi_11;			\ | ||||
|   result_32+= UChi_12; | ||||
|  | ||||
| #define TM_RECON_ACCUM\ | ||||
|   result_00+= UChi_00;\ | ||||
|   result_01+= UChi_01;\ | ||||
|   result_02+= UChi_02;\ | ||||
|   result_10+= UChi_10;\ | ||||
|   result_11+= UChi_11;\ | ||||
|   result_12+= UChi_12;\ | ||||
|   result_20-= UChi_00;	\ | ||||
|   result_21-= UChi_01;	\ | ||||
|   result_22-= UChi_02;	\ | ||||
|   result_30-= UChi_10;	\ | ||||
|   result_31-= UChi_11;	\ | ||||
|   result_32-= UChi_12; | ||||
|  | ||||
| #define HAND_STENCIL_LEGA(PROJ,PERM,DIR,RECON)	\ | ||||
|   SE=&st_p[DIR+8*ss];			\ | ||||
|   ptype=st_perm[DIR];			\ | ||||
|   offset = SE->_offset;				\ | ||||
|   local  = SE->_is_local;			\ | ||||
|   perm   = SE->_permute;			\ | ||||
|   if ( local ) {				\ | ||||
|     LOAD_CHIMU(PERM);				\ | ||||
|     PROJ;					\ | ||||
|     if ( perm) {				\ | ||||
|       PERMUTE_DIR(PERM);			\ | ||||
|     }						\ | ||||
|   } else {					\ | ||||
|     LOAD_CHI;					\ | ||||
|   }						\ | ||||
|   MULT_2SPIN(DIR);				\ | ||||
|   RECON;					 | ||||
|  | ||||
| #define HAND_STENCIL_LEG(PROJ,PERM,DIR,RECON)	\ | ||||
|   SE=&st_p[DIR+8*ss];			\ | ||||
|   ptype=st_perm[DIR];			\ | ||||
|   offset = SE->_offset;				\ | ||||
|   local  = SE->_is_local;			\ | ||||
|   perm   = SE->_permute;			\ | ||||
|   LOAD_CHIMU(PERM);				\ | ||||
|   PROJ;						\ | ||||
|   MULT_2SPIN(DIR);				\ | ||||
|   RECON;					 | ||||
|  | ||||
|  | ||||
| #define HAND_STENCIL_LEG_INT(PROJ,PERM,DIR,RECON)	\ | ||||
|   SE=&st_p[DIR+8*ss];					\ | ||||
|   ptype=st_perm[DIR];					\ | ||||
|   offset = SE->_offset;				\ | ||||
|   local  = SE->_is_local;			\ | ||||
|   perm   = SE->_permute;			\ | ||||
|   if ( local ) {				\ | ||||
|     LOAD_CHIMU;					\ | ||||
|     PROJ;					\ | ||||
|     if ( perm) {				\ | ||||
|       PERMUTE_DIR(PERM);			\ | ||||
|     }						\ | ||||
|   } else if ( st.same_node[DIR] ) {		\ | ||||
|     LOAD_CHI;					\ | ||||
|   }						\ | ||||
|   if (local || st.same_node[DIR] ) {		\ | ||||
|     MULT_2SPIN(DIR);				\ | ||||
|     RECON;					\ | ||||
|   } | ||||
|  | ||||
| #define HAND_STENCIL_LEG_EXT(PROJ,PERM,DIR,RECON)	\ | ||||
|   SE=st.GetEntry(ptype,DIR,ss);			\ | ||||
|   offset = SE->_offset;				\ | ||||
|   if((!SE->_is_local)&&(!st.same_node[DIR]) ) {	\ | ||||
|     LOAD_CHI;					\ | ||||
|     MULT_2SPIN(DIR);				\ | ||||
|     RECON;					\ | ||||
|     nmu++;					\ | ||||
|   } | ||||
|  | ||||
| #define HAND_RESULT(ss)				\ | ||||
|   {						\ | ||||
|     SiteSpinor & ref (out[ss]);			\ | ||||
|     coalescedWrite(ref()(0)(0),result_00);		\ | ||||
|     coalescedWrite(ref()(0)(1),result_01);		\ | ||||
|     coalescedWrite(ref()(0)(2),result_02);		\ | ||||
|     coalescedWrite(ref()(1)(0),result_10);		\ | ||||
|     coalescedWrite(ref()(1)(1),result_11);		\ | ||||
|     coalescedWrite(ref()(1)(2),result_12);		\ | ||||
|     coalescedWrite(ref()(2)(0),result_20);		\ | ||||
|     coalescedWrite(ref()(2)(1),result_21);		\ | ||||
|     coalescedWrite(ref()(2)(2),result_22);		\ | ||||
|     coalescedWrite(ref()(3)(0),result_30);		\ | ||||
|     coalescedWrite(ref()(3)(1),result_31);		\ | ||||
|     coalescedWrite(ref()(3)(2),result_32);		\ | ||||
|   } | ||||
|  | ||||
| #define HAND_RESULT_EXT(ss)			\ | ||||
|   if (nmu){					\ | ||||
|     SiteSpinor & ref (out[ss]);		\ | ||||
|     ref()(0)(0)+=result_00;		\ | ||||
|     ref()(0)(1)+=result_01;		\ | ||||
|     ref()(0)(2)+=result_02;		\ | ||||
|     ref()(1)(0)+=result_10;		\ | ||||
|     ref()(1)(1)+=result_11;		\ | ||||
|     ref()(1)(2)+=result_12;		\ | ||||
|     ref()(2)(0)+=result_20;		\ | ||||
|     ref()(2)(1)+=result_21;		\ | ||||
|     ref()(2)(2)+=result_22;		\ | ||||
|     ref()(3)(0)+=result_30;		\ | ||||
|     ref()(3)(1)+=result_31;		\ | ||||
|     ref()(3)(2)+=result_32;		\ | ||||
|   } | ||||
|  | ||||
| #define HAND_DECLARATIONS(Simd)			\ | ||||
|   Simd result_00;				\ | ||||
|   Simd result_01;				\ | ||||
|   Simd result_02;				\ | ||||
|   Simd result_10;				\ | ||||
|   Simd result_11;				\ | ||||
|   Simd result_12;				\ | ||||
|   Simd result_20;				\ | ||||
|   Simd result_21;				\ | ||||
|   Simd result_22;				\ | ||||
|   Simd result_30;				\ | ||||
|   Simd result_31;				\ | ||||
|   Simd result_32;				\ | ||||
|   Simd Chi_00;					\ | ||||
|   Simd Chi_01;					\ | ||||
|   Simd Chi_02;					\ | ||||
|   Simd Chi_10;					\ | ||||
|   Simd Chi_11;					\ | ||||
|   Simd Chi_12;					\ | ||||
|   Simd UChi_00;					\ | ||||
|   Simd UChi_01;					\ | ||||
|   Simd UChi_02;					\ | ||||
|   Simd UChi_10;					\ | ||||
|   Simd UChi_11;					\ | ||||
|   Simd UChi_12;					\ | ||||
|   Simd U_00;					\ | ||||
|   Simd U_10;					\ | ||||
|   Simd U_20;					\ | ||||
|   Simd U_01;					\ | ||||
|   Simd U_11;					\ | ||||
|   Simd U_21; | ||||
|  | ||||
| #define ZERO_RESULT				\ | ||||
|   result_00=Zero();				\ | ||||
|   result_01=Zero();				\ | ||||
|   result_02=Zero();				\ | ||||
|   result_10=Zero();				\ | ||||
|   result_11=Zero();				\ | ||||
|   result_12=Zero();				\ | ||||
|   result_20=Zero();				\ | ||||
|   result_21=Zero();				\ | ||||
|   result_22=Zero();				\ | ||||
|   result_30=Zero();				\ | ||||
|   result_31=Zero();				\ | ||||
|   result_32=Zero();			 | ||||
|  | ||||
| #define Chimu_00 Chi_00 | ||||
| #define Chimu_01 Chi_01 | ||||
| #define Chimu_02 Chi_02 | ||||
| #define Chimu_10 Chi_10 | ||||
| #define Chimu_11 Chi_11 | ||||
| #define Chimu_12 Chi_12 | ||||
| #define Chimu_20 UChi_00 | ||||
| #define Chimu_21 UChi_01 | ||||
| #define Chimu_22 UChi_02 | ||||
| #define Chimu_30 UChi_10 | ||||
| #define Chimu_31 UChi_11 | ||||
| #define Chimu_32 UChi_12 | ||||
|  | ||||
| NAMESPACE_BEGIN(Grid); | ||||
|  | ||||
| template<class Impl> accelerator_inline void  | ||||
| WilsonKernels<Impl>::HandDhopSiteSycl(StencilVector st_perm,StencilEntry *st_p, SiteDoubledGaugeField *U,SiteHalfSpinor  *buf, | ||||
| 				      int ss,int sU,const SiteSpinor *in, SiteSpinor *out) | ||||
| { | ||||
| // T==0, Z==1, Y==2, Z==3 expect 1,2,2,2 simd layout etc... | ||||
|   typedef typename Simd::scalar_type S; | ||||
|   typedef typename Simd::vector_type V; | ||||
|   typedef iSinglet<Simd> vCplx; | ||||
|   //  typedef decltype( coalescedRead( vCplx()()() )) Simt; | ||||
|   typedef decltype( coalescedRead( in[0]()(0)(0) )) Simt; | ||||
|  | ||||
|   HAND_DECLARATIONS(Simt); | ||||
|  | ||||
|   int offset,local,perm, ptype; | ||||
|   StencilEntry *SE; | ||||
|   HAND_STENCIL_LEG(XM_PROJ,3,Xp,XM_RECON); | ||||
|   HAND_STENCIL_LEG(YM_PROJ,2,Yp,YM_RECON_ACCUM); | ||||
|   HAND_STENCIL_LEG(ZM_PROJ,1,Zp,ZM_RECON_ACCUM); | ||||
|   HAND_STENCIL_LEG(TM_PROJ,0,Tp,TM_RECON_ACCUM); | ||||
|   HAND_STENCIL_LEG(XP_PROJ,3,Xm,XP_RECON_ACCUM); | ||||
|   HAND_STENCIL_LEG(YP_PROJ,2,Ym,YP_RECON_ACCUM); | ||||
|   HAND_STENCIL_LEG(ZP_PROJ,1,Zm,ZP_RECON_ACCUM); | ||||
|   HAND_STENCIL_LEG(TP_PROJ,0,Tm,TP_RECON_ACCUM); | ||||
|   HAND_RESULT(ss); | ||||
| } | ||||
|  | ||||
| ////////////// Wilson ; uses this implementation ///////////////////// | ||||
|  | ||||
| NAMESPACE_END(Grid); | ||||
| #undef LOAD_CHIMU   | ||||
| #undef LOAD_CHI  | ||||
| #undef MULT_2SPIN | ||||
| #undef PERMUTE_DIR | ||||
| #undef XP_PROJ   | ||||
| #undef YP_PROJ   | ||||
| #undef ZP_PROJ   | ||||
| #undef TP_PROJ   | ||||
| #undef XM_PROJ   | ||||
| #undef YM_PROJ   | ||||
| #undef ZM_PROJ   | ||||
| #undef TM_PROJ   | ||||
| #undef XP_RECON  | ||||
| #undef XP_RECON_ACCUM  | ||||
| #undef XM_RECON  | ||||
| #undef XM_RECON_ACCUM  | ||||
| #undef YP_RECON_ACCUM  | ||||
| #undef YM_RECON_ACCUM  | ||||
| #undef ZP_RECON_ACCUM  | ||||
| #undef ZM_RECON_ACCUM  | ||||
| #undef TP_RECON_ACCUM  | ||||
| #undef TM_RECON_ACCUM  | ||||
| #undef ZERO_RESULT				  | ||||
| #undef Chimu_00 | ||||
| #undef Chimu_01 | ||||
| #undef Chimu_02 | ||||
| #undef Chimu_10 | ||||
| #undef Chimu_11 | ||||
| #undef Chimu_12 | ||||
| #undef Chimu_20 | ||||
| #undef Chimu_21 | ||||
| #undef Chimu_22 | ||||
| #undef Chimu_30 | ||||
| #undef Chimu_31 | ||||
| #undef Chimu_32 | ||||
| #undef HAND_STENCIL_LEG | ||||
| #undef HAND_STENCIL_LEG_INT | ||||
| #undef HAND_STENCIL_LEG_EXT | ||||
| #undef HAND_RESULT | ||||
| #undef HAND_RESULT_INT | ||||
| #undef HAND_RESULT_EXT | ||||
| #undef HAND_DECLARATIONS | ||||
| @@ -115,9 +115,9 @@ accelerator_inline void get_stencil(StencilEntry * mem, StencilEntry &chip) | ||||
|   // All legs kernels ; comms then compute | ||||
|   //////////////////////////////////////////////////////////////////// | ||||
| template <class Impl> accelerator_inline | ||||
| void WilsonKernels<Impl>::GenericDhopSiteDag(StencilView &st, DoubledGaugeFieldView &U, | ||||
| void WilsonKernels<Impl>::GenericDhopSiteDag(const StencilView &st, const DoubledGaugeFieldView &U, | ||||
|  					     SiteHalfSpinor *buf, int sF, | ||||
| 					     int sU, const FermionFieldView &in, FermionFieldView &out) | ||||
| 					     int sU, const FermionFieldView &in, const FermionFieldView &out) | ||||
| { | ||||
|   typedef decltype(coalescedRead(buf[0]))   calcHalfSpinor; | ||||
|   typedef decltype(coalescedRead(in[0])) calcSpinor; | ||||
| @@ -141,9 +141,9 @@ void WilsonKernels<Impl>::GenericDhopSiteDag(StencilView &st, DoubledGaugeFieldV | ||||
| }; | ||||
|  | ||||
| template <class Impl> accelerator_inline | ||||
| void WilsonKernels<Impl>::GenericDhopSite(StencilView &st, DoubledGaugeFieldView &U, | ||||
| void WilsonKernels<Impl>::GenericDhopSite(const StencilView &st, const DoubledGaugeFieldView &U, | ||||
|  					  SiteHalfSpinor *buf, int sF, | ||||
| 					  int sU, const FermionFieldView &in, FermionFieldView &out) | ||||
| 					  int sU, const FermionFieldView &in, const FermionFieldView &out) | ||||
| { | ||||
|   typedef decltype(coalescedRead(buf[0])) calcHalfSpinor; | ||||
|   typedef decltype(coalescedRead(in[0]))  calcSpinor; | ||||
| @@ -170,9 +170,9 @@ void WilsonKernels<Impl>::GenericDhopSite(StencilView &st, DoubledGaugeFieldView | ||||
|   // Interior kernels | ||||
|   //////////////////////////////////////////////////////////////////// | ||||
| template <class Impl> accelerator_inline | ||||
| void WilsonKernels<Impl>::GenericDhopSiteDagInt(StencilView &st,  DoubledGaugeFieldView &U, | ||||
| void WilsonKernels<Impl>::GenericDhopSiteDagInt(const StencilView &st, const DoubledGaugeFieldView &U, | ||||
|  						SiteHalfSpinor *buf, int sF, | ||||
| 						int sU, const FermionFieldView &in, FermionFieldView &out) | ||||
| 						int sU, const FermionFieldView &in, const FermionFieldView &out) | ||||
| { | ||||
|   typedef decltype(coalescedRead(buf[0])) calcHalfSpinor; | ||||
|   typedef decltype(coalescedRead(in[0]))  calcSpinor; | ||||
| @@ -198,9 +198,9 @@ void WilsonKernels<Impl>::GenericDhopSiteDagInt(StencilView &st,  DoubledGaugeFi | ||||
| }; | ||||
|  | ||||
| template <class Impl> accelerator_inline | ||||
| void WilsonKernels<Impl>::GenericDhopSiteInt(StencilView &st,  DoubledGaugeFieldView &U, | ||||
| void WilsonKernels<Impl>::GenericDhopSiteInt(const StencilView &st, const DoubledGaugeFieldView &U, | ||||
| 					     SiteHalfSpinor *buf, int sF, | ||||
| 							 int sU, const FermionFieldView &in, FermionFieldView &out) | ||||
| 					     int sU, const FermionFieldView &in, const FermionFieldView &out) | ||||
| { | ||||
|   typedef decltype(coalescedRead(buf[0])) calcHalfSpinor; | ||||
|   typedef decltype(coalescedRead(in[0]))  calcSpinor; | ||||
| @@ -228,9 +228,9 @@ void WilsonKernels<Impl>::GenericDhopSiteInt(StencilView &st,  DoubledGaugeField | ||||
| // Exterior kernels | ||||
| //////////////////////////////////////////////////////////////////// | ||||
| template <class Impl> accelerator_inline | ||||
| void WilsonKernels<Impl>::GenericDhopSiteDagExt(StencilView &st,  DoubledGaugeFieldView &U, | ||||
| void WilsonKernels<Impl>::GenericDhopSiteDagExt(const StencilView &st, const DoubledGaugeFieldView &U, | ||||
|  						SiteHalfSpinor *buf, int sF, | ||||
| 						int sU, const FermionFieldView &in, FermionFieldView &out) | ||||
| 						int sU, const FermionFieldView &in, const FermionFieldView &out) | ||||
| { | ||||
|   typedef decltype(coalescedRead(buf[0])) calcHalfSpinor; | ||||
|   typedef decltype(coalescedRead(in[0]))  calcSpinor; | ||||
| @@ -259,9 +259,9 @@ void WilsonKernels<Impl>::GenericDhopSiteDagExt(StencilView &st,  DoubledGaugeFi | ||||
| }; | ||||
|  | ||||
| template <class Impl> accelerator_inline | ||||
| void WilsonKernels<Impl>::GenericDhopSiteExt(StencilView &st,  DoubledGaugeFieldView &U, | ||||
| void WilsonKernels<Impl>::GenericDhopSiteExt(const StencilView &st, const DoubledGaugeFieldView &U, | ||||
|  					     SiteHalfSpinor *buf, int sF, | ||||
| 					     int sU, const FermionFieldView &in, FermionFieldView &out) | ||||
| 					     int sU, const FermionFieldView &in, const FermionFieldView &out) | ||||
| { | ||||
|   typedef decltype(coalescedRead(buf[0])) calcHalfSpinor; | ||||
|   typedef decltype(coalescedRead(in[0]))  calcSpinor; | ||||
| @@ -291,8 +291,8 @@ void WilsonKernels<Impl>::GenericDhopSiteExt(StencilView &st,  DoubledGaugeField | ||||
|  | ||||
| #define DhopDirMacro(Dir,spProj,spRecon)	\ | ||||
|   template <class Impl> accelerator_inline				\ | ||||
|   void WilsonKernels<Impl>::DhopDir##Dir(StencilView &st, DoubledGaugeFieldView &U,SiteHalfSpinor *buf, int sF, \ | ||||
| 					 int sU, const FermionFieldView &in, FermionFieldView &out, int dir) \ | ||||
|   void WilsonKernels<Impl>::DhopDir##Dir(const StencilView &st, const DoubledGaugeFieldView &U,SiteHalfSpinor *buf, int sF, \ | ||||
| 					 int sU, const FermionFieldView &in, const FermionFieldView &out, int dir) \ | ||||
|   {									\ | ||||
|   typedef decltype(coalescedRead(buf[0])) calcHalfSpinor;		\ | ||||
|   typedef decltype(coalescedRead(in[0]))  calcSpinor;			\ | ||||
| @@ -319,8 +319,8 @@ DhopDirMacro(Zm,spProjZm,spReconZm); | ||||
| DhopDirMacro(Tm,spProjTm,spReconTm); | ||||
|  | ||||
| template <class Impl> accelerator_inline | ||||
| void WilsonKernels<Impl>::DhopDirK( StencilView &st, DoubledGaugeFieldView &U,SiteHalfSpinor *buf, int sF, | ||||
| 				    int sU, const FermionFieldView &in, FermionFieldView &out, int dir, int gamma) | ||||
| void WilsonKernels<Impl>::DhopDirK(const StencilView &st, const DoubledGaugeFieldView &U,SiteHalfSpinor *buf, int sF, | ||||
| 				   int sU, const FermionFieldView &in, const FermionFieldView &out, int dir, int gamma) | ||||
| { | ||||
|   typedef decltype(coalescedRead(buf[0])) calcHalfSpinor; | ||||
|   typedef decltype(coalescedRead(in[0]))  calcSpinor; | ||||
| @@ -416,6 +416,14 @@ void WilsonKernels<Impl>::DhopDirKernel( StencilImpl &st, DoubledGaugeField &U,S | ||||
| #undef LoopBody | ||||
| } | ||||
|  | ||||
| #define KERNEL_CALLNB(A) \ | ||||
|   const uint64_t    NN = Nsite*Ls;					\ | ||||
|   accelerator_forNB( ss, NN, Simd::Nsimd(), {				\ | ||||
|       int sF = ss;							\ | ||||
|       int sU = ss/Ls;							\ | ||||
|       WilsonKernels<Impl>::A(st_v,U_v,buf,sF,sU,in_v,out_v);		\ | ||||
|   }); | ||||
|  | ||||
| #define KERNEL_CALL_TMP(A) \ | ||||
|   const uint64_t    NN = Nsite*Ls;					\ | ||||
|   auto U_p = & U_v[0];							\ | ||||
| @@ -430,14 +438,6 @@ void WilsonKernels<Impl>::DhopDirKernel( StencilImpl &st, DoubledGaugeField &U,S | ||||
|     });									\ | ||||
|   accelerator_barrier(); | ||||
|  | ||||
| #define KERNEL_CALLNB(A)						\ | ||||
|   const uint64_t    NN = Nsite*Ls;					\ | ||||
|   accelerator_forNB( ss, NN, Simd::Nsimd(), {				\ | ||||
|       int sF = ss;							\ | ||||
|       int sU = ss/Ls;							\ | ||||
|       WilsonKernels<Impl>::A(st_v,U_v,buf,sF,sU,in_v,out_v);		\ | ||||
|   }); | ||||
|  | ||||
| #define KERNEL_CALL(A) KERNEL_CALLNB(A); accelerator_barrier(); | ||||
|  | ||||
| #define ASM_CALL(A)							\ | ||||
| @@ -459,24 +459,21 @@ void WilsonKernels<Impl>::DhopKernel(int Opt,StencilImpl &st,  DoubledGaugeField | ||||
|  | ||||
|    if( interior && exterior ) { | ||||
|      if (Opt == WilsonKernelsStatic::OptGeneric    ) { KERNEL_CALL(GenericDhopSite); return;} | ||||
| #ifdef SYCL_HACK      | ||||
|      if (Opt == WilsonKernelsStatic::OptHandUnroll ) { KERNEL_CALL_TMP(HandDhopSiteSycl);    return; } | ||||
| #else | ||||
|      if (Opt == WilsonKernelsStatic::OptHandUnroll ) { KERNEL_CALL(HandDhopSite);    return;} | ||||
| #endif      | ||||
| #ifndef GRID_CUDA | ||||
|      if (Opt == WilsonKernelsStatic::OptHandUnroll ) { KERNEL_CALL_TMP(HandDhopSiteSycl);    return; } | ||||
|      //     if (Opt == WilsonKernelsStatic::OptHandUnroll ) { KERNEL_CALL(HandDhopSite);    return;} | ||||
|      if (Opt == WilsonKernelsStatic::OptInlineAsm  ) {  ASM_CALL(AsmDhopSite);    return;} | ||||
| #endif | ||||
|    } else if( interior ) { | ||||
|      if (Opt == WilsonKernelsStatic::OptGeneric    ) { KERNEL_CALLNB(GenericDhopSiteInt); return;} | ||||
|      if (Opt == WilsonKernelsStatic::OptHandUnroll ) { KERNEL_CALLNB(HandDhopSiteInt);    return;} | ||||
| #ifndef GRID_CUDA | ||||
|      if (Opt == WilsonKernelsStatic::OptHandUnroll ) { KERNEL_CALLNB(HandDhopSiteInt);    return;} | ||||
|      if (Opt == WilsonKernelsStatic::OptInlineAsm  ) {  ASM_CALL(AsmDhopSiteInt);    return;} | ||||
| #endif | ||||
|    } else if( exterior ) { | ||||
|      if (Opt == WilsonKernelsStatic::OptGeneric    ) { KERNEL_CALL(GenericDhopSiteExt); return;} | ||||
|      if (Opt == WilsonKernelsStatic::OptHandUnroll ) { KERNEL_CALL(HandDhopSiteExt);    return;} | ||||
| #ifndef GRID_CUDA | ||||
|      if (Opt == WilsonKernelsStatic::OptHandUnroll ) { KERNEL_CALL(HandDhopSiteExt);    return;} | ||||
|      if (Opt == WilsonKernelsStatic::OptInlineAsm  ) {  ASM_CALL(AsmDhopSiteExt);    return;} | ||||
| #endif | ||||
|    } | ||||
| @@ -494,20 +491,20 @@ void WilsonKernels<Impl>::DhopKernel(int Opt,StencilImpl &st,  DoubledGaugeField | ||||
|  | ||||
|    if( interior && exterior ) { | ||||
|      if (Opt == WilsonKernelsStatic::OptGeneric    ) { KERNEL_CALL(GenericDhopSiteDag); return;} | ||||
|      if (Opt == WilsonKernelsStatic::OptHandUnroll ) { KERNEL_CALL(HandDhopSiteDag);    return;} | ||||
| #ifndef GRID_CUDA | ||||
|      if (Opt == WilsonKernelsStatic::OptHandUnroll ) { KERNEL_CALL(HandDhopSiteDag);    return;} | ||||
|      if (Opt == WilsonKernelsStatic::OptInlineAsm  ) {  ASM_CALL(AsmDhopSiteDag);     return;} | ||||
| #endif | ||||
|    } else if( interior ) { | ||||
|      if (Opt == WilsonKernelsStatic::OptGeneric    ) { KERNEL_CALL(GenericDhopSiteDagInt); return;} | ||||
|      if (Opt == WilsonKernelsStatic::OptHandUnroll ) { KERNEL_CALL(HandDhopSiteDagInt);    return;} | ||||
| #ifndef GRID_CUDA | ||||
|      if (Opt == WilsonKernelsStatic::OptHandUnroll ) { KERNEL_CALL(HandDhopSiteDagInt);    return;} | ||||
|      if (Opt == WilsonKernelsStatic::OptInlineAsm  ) {  ASM_CALL(AsmDhopSiteDagInt);     return;} | ||||
| #endif | ||||
|    } else if( exterior ) { | ||||
|      if (Opt == WilsonKernelsStatic::OptGeneric    ) { KERNEL_CALL(GenericDhopSiteDagExt); return;} | ||||
|      if (Opt == WilsonKernelsStatic::OptHandUnroll ) { KERNEL_CALL(HandDhopSiteDagExt);    return;} | ||||
| #ifndef GRID_CUDA | ||||
|      if (Opt == WilsonKernelsStatic::OptHandUnroll ) { KERNEL_CALL(HandDhopSiteDagExt);    return;} | ||||
|      if (Opt == WilsonKernelsStatic::OptInlineAsm  ) {  ASM_CALL(AsmDhopSiteDagExt);     return;} | ||||
| #endif | ||||
|    } | ||||
|   | ||||
| @@ -1,51 +0,0 @@ | ||||
| /************************************************************************************* | ||||
|  | ||||
| Grid physics library, www.github.com/paboyle/Grid | ||||
|  | ||||
| Source file: ./lib/qcd/action/fermion/WilsonKernels.cc | ||||
|  | ||||
| Copyright (C) 2015, 2020 | ||||
|  | ||||
| Author: Peter Boyle <paboyle@ph.ed.ac.uk> | ||||
| Author: Peter Boyle <peterboyle@Peters-MacBook-Pro-2.local> | ||||
| Author: paboyle <paboyle@ph.ed.ac.uk> | ||||
| Author: Nils Meyer <nils.meyer@ur.de> Regensburg University | ||||
|  | ||||
| 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 | ||||
| the Free Software Foundation; either version 2 of the License, or | ||||
| (at your option) any later version. | ||||
|  | ||||
| This program is distributed in the hope that it will be useful, | ||||
| but WITHOUT ANY WARRANTY; without even the implied warranty of | ||||
| MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE.  See the | ||||
| GNU General Public License for more details. | ||||
|  | ||||
| You should have received a copy of the GNU General Public License along | ||||
| with this program; if not, write to the Free Software Foundation, Inc., | ||||
| 51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. | ||||
|  | ||||
| See the full license in the file "LICENSE" in the top level distribution | ||||
| directory | ||||
| *************************************************************************************/ | ||||
| /*  END LEGAL */ | ||||
| #include <Grid/qcd/action/fermion/FermionCore.h> | ||||
| #include <Grid/qcd/action/fermion/implementation/WilsonKernelsImplementation.h> | ||||
| #include <Grid/qcd/action/fermion/implementation/WilsonKernelsHandImplementation.h> | ||||
|  | ||||
| #ifndef AVX512 | ||||
| #ifndef QPX | ||||
| #ifndef A64FX | ||||
| #ifndef A64FXFIXEDSIZE | ||||
| #include <Grid/qcd/action/fermion/implementation/WilsonKernelsAsmImplementation.h> | ||||
| #endif | ||||
| #endif | ||||
| #endif | ||||
| #endif | ||||
|  | ||||
| NAMESPACE_BEGIN(Grid); | ||||
|  | ||||
| #include "impl.h" | ||||
| template class WilsonKernels<IMPLEMENTATION>; | ||||
|  | ||||
| NAMESPACE_END(Grid); | ||||
| @@ -0,0 +1 @@ | ||||
| ../WilsonKernelsInstantiation.cc.master | ||||
| @@ -1,51 +0,0 @@ | ||||
| /************************************************************************************* | ||||
|  | ||||
| Grid physics library, www.github.com/paboyle/Grid | ||||
|  | ||||
| Source file: ./lib/qcd/action/fermion/WilsonKernels.cc | ||||
|  | ||||
| Copyright (C) 2015, 2020 | ||||
|  | ||||
| Author: Peter Boyle <paboyle@ph.ed.ac.uk> | ||||
| Author: Peter Boyle <peterboyle@Peters-MacBook-Pro-2.local> | ||||
| Author: paboyle <paboyle@ph.ed.ac.uk> | ||||
| Author: Nils Meyer <nils.meyer@ur.de> Regensburg University | ||||
|  | ||||
| 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 | ||||
| the Free Software Foundation; either version 2 of the License, or | ||||
| (at your option) any later version. | ||||
|  | ||||
| This program is distributed in the hope that it will be useful, | ||||
| but WITHOUT ANY WARRANTY; without even the implied warranty of | ||||
| MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE.  See the | ||||
| GNU General Public License for more details. | ||||
|  | ||||
| You should have received a copy of the GNU General Public License along | ||||
| with this program; if not, write to the Free Software Foundation, Inc., | ||||
| 51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. | ||||
|  | ||||
| See the full license in the file "LICENSE" in the top level distribution | ||||
| directory | ||||
| *************************************************************************************/ | ||||
| /*  END LEGAL */ | ||||
| #include <Grid/qcd/action/fermion/FermionCore.h> | ||||
| #include <Grid/qcd/action/fermion/implementation/WilsonKernelsImplementation.h> | ||||
| #include <Grid/qcd/action/fermion/implementation/WilsonKernelsHandImplementation.h> | ||||
|  | ||||
| #ifndef AVX512 | ||||
| #ifndef QPX | ||||
| #ifndef A64FX | ||||
| #ifndef A64FXFIXEDSIZE | ||||
| #include <Grid/qcd/action/fermion/implementation/WilsonKernelsAsmImplementation.h> | ||||
| #endif | ||||
| #endif | ||||
| #endif | ||||
| #endif | ||||
|  | ||||
| NAMESPACE_BEGIN(Grid); | ||||
|  | ||||
| #include "impl.h" | ||||
| template class WilsonKernels<IMPLEMENTATION>; | ||||
|  | ||||
| NAMESPACE_END(Grid); | ||||
| @@ -0,0 +1 @@ | ||||
| ../WilsonKernelsInstantiation.cc.master | ||||
| @@ -1,51 +0,0 @@ | ||||
| /************************************************************************************* | ||||
|  | ||||
| Grid physics library, www.github.com/paboyle/Grid | ||||
|  | ||||
| Source file: ./lib/qcd/action/fermion/WilsonKernels.cc | ||||
|  | ||||
| Copyright (C) 2015, 2020 | ||||
|  | ||||
| Author: Peter Boyle <paboyle@ph.ed.ac.uk> | ||||
| Author: Peter Boyle <peterboyle@Peters-MacBook-Pro-2.local> | ||||
| Author: paboyle <paboyle@ph.ed.ac.uk> | ||||
| Author: Nils Meyer <nils.meyer@ur.de> Regensburg University | ||||
|  | ||||
| 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 | ||||
| the Free Software Foundation; either version 2 of the License, or | ||||
| (at your option) any later version. | ||||
|  | ||||
| This program is distributed in the hope that it will be useful, | ||||
| but WITHOUT ANY WARRANTY; without even the implied warranty of | ||||
| MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE.  See the | ||||
| GNU General Public License for more details. | ||||
|  | ||||
| You should have received a copy of the GNU General Public License along | ||||
| with this program; if not, write to the Free Software Foundation, Inc., | ||||
| 51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. | ||||
|  | ||||
| See the full license in the file "LICENSE" in the top level distribution | ||||
| directory | ||||
| *************************************************************************************/ | ||||
| /*  END LEGAL */ | ||||
| #include <Grid/qcd/action/fermion/FermionCore.h> | ||||
| #include <Grid/qcd/action/fermion/implementation/WilsonKernelsImplementation.h> | ||||
| #include <Grid/qcd/action/fermion/implementation/WilsonKernelsHandImplementation.h> | ||||
|  | ||||
| #ifndef AVX512 | ||||
| #ifndef QPX | ||||
| #ifndef A64FX | ||||
| #ifndef A64FXFIXEDSIZE | ||||
| #include <Grid/qcd/action/fermion/implementation/WilsonKernelsAsmImplementation.h> | ||||
| #endif | ||||
| #endif | ||||
| #endif | ||||
| #endif | ||||
|  | ||||
| NAMESPACE_BEGIN(Grid); | ||||
|  | ||||
| #include "impl.h" | ||||
| template class WilsonKernels<IMPLEMENTATION>; | ||||
|  | ||||
| NAMESPACE_END(Grid); | ||||
| @@ -0,0 +1 @@ | ||||
| ../WilsonKernelsInstantiation.cc.master | ||||
| @@ -1,51 +0,0 @@ | ||||
| /************************************************************************************* | ||||
|  | ||||
| Grid physics library, www.github.com/paboyle/Grid | ||||
|  | ||||
| Source file: ./lib/qcd/action/fermion/WilsonKernels.cc | ||||
|  | ||||
| Copyright (C) 2015, 2020 | ||||
|  | ||||
| Author: Peter Boyle <paboyle@ph.ed.ac.uk> | ||||
| Author: Peter Boyle <peterboyle@Peters-MacBook-Pro-2.local> | ||||
| Author: paboyle <paboyle@ph.ed.ac.uk> | ||||
| Author: Nils Meyer <nils.meyer@ur.de> Regensburg University | ||||
|  | ||||
| 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 | ||||
| the Free Software Foundation; either version 2 of the License, or | ||||
| (at your option) any later version. | ||||
|  | ||||
| This program is distributed in the hope that it will be useful, | ||||
| but WITHOUT ANY WARRANTY; without even the implied warranty of | ||||
| MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE.  See the | ||||
| GNU General Public License for more details. | ||||
|  | ||||
| You should have received a copy of the GNU General Public License along | ||||
| with this program; if not, write to the Free Software Foundation, Inc., | ||||
| 51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. | ||||
|  | ||||
| See the full license in the file "LICENSE" in the top level distribution | ||||
| directory | ||||
| *************************************************************************************/ | ||||
| /*  END LEGAL */ | ||||
| #include <Grid/qcd/action/fermion/FermionCore.h> | ||||
| #include <Grid/qcd/action/fermion/implementation/WilsonKernelsImplementation.h> | ||||
| #include <Grid/qcd/action/fermion/implementation/WilsonKernelsHandImplementation.h> | ||||
|  | ||||
| #ifndef AVX512 | ||||
| #ifndef QPX | ||||
| #ifndef A64FX | ||||
| #ifndef A64FXFIXEDSIZE | ||||
| #include <Grid/qcd/action/fermion/implementation/WilsonKernelsAsmImplementation.h> | ||||
| #endif | ||||
| #endif | ||||
| #endif | ||||
| #endif | ||||
|  | ||||
| NAMESPACE_BEGIN(Grid); | ||||
|  | ||||
| #include "impl.h" | ||||
| template class WilsonKernels<IMPLEMENTATION>; | ||||
|  | ||||
| NAMESPACE_END(Grid); | ||||
| @@ -0,0 +1 @@ | ||||
| ../WilsonKernelsInstantiation.cc.master | ||||
| @@ -1,51 +0,0 @@ | ||||
| /************************************************************************************* | ||||
|  | ||||
| Grid physics library, www.github.com/paboyle/Grid | ||||
|  | ||||
| Source file: ./lib/qcd/action/fermion/WilsonKernels.cc | ||||
|  | ||||
| Copyright (C) 2015, 2020 | ||||
|  | ||||
| Author: Peter Boyle <paboyle@ph.ed.ac.uk> | ||||
| Author: Peter Boyle <peterboyle@Peters-MacBook-Pro-2.local> | ||||
| Author: paboyle <paboyle@ph.ed.ac.uk> | ||||
| Author: Nils Meyer <nils.meyer@ur.de> Regensburg University | ||||
|  | ||||
| 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 | ||||
| the Free Software Foundation; either version 2 of the License, or | ||||
| (at your option) any later version. | ||||
|  | ||||
| This program is distributed in the hope that it will be useful, | ||||
| but WITHOUT ANY WARRANTY; without even the implied warranty of | ||||
| MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE.  See the | ||||
| GNU General Public License for more details. | ||||
|  | ||||
| You should have received a copy of the GNU General Public License along | ||||
| with this program; if not, write to the Free Software Foundation, Inc., | ||||
| 51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. | ||||
|  | ||||
| See the full license in the file "LICENSE" in the top level distribution | ||||
| directory | ||||
| *************************************************************************************/ | ||||
| /*  END LEGAL */ | ||||
| #include <Grid/qcd/action/fermion/FermionCore.h> | ||||
| #include <Grid/qcd/action/fermion/implementation/WilsonKernelsImplementation.h> | ||||
| #include <Grid/qcd/action/fermion/implementation/WilsonKernelsHandImplementation.h> | ||||
|  | ||||
| #ifndef AVX512 | ||||
| #ifndef QPX | ||||
| #ifndef A64FX | ||||
| #ifndef A64FXFIXEDSIZE | ||||
| #include <Grid/qcd/action/fermion/implementation/WilsonKernelsAsmImplementation.h> | ||||
| #endif | ||||
| #endif | ||||
| #endif | ||||
| #endif | ||||
|  | ||||
| NAMESPACE_BEGIN(Grid); | ||||
|  | ||||
| #include "impl.h" | ||||
| template class WilsonKernels<IMPLEMENTATION>; | ||||
|  | ||||
| NAMESPACE_END(Grid); | ||||
| @@ -0,0 +1 @@ | ||||
| ../WilsonKernelsInstantiation.cc.master | ||||
| @@ -1,51 +0,0 @@ | ||||
| /************************************************************************************* | ||||
|  | ||||
| Grid physics library, www.github.com/paboyle/Grid | ||||
|  | ||||
| Source file: ./lib/qcd/action/fermion/WilsonKernels.cc | ||||
|  | ||||
| Copyright (C) 2015, 2020 | ||||
|  | ||||
| Author: Peter Boyle <paboyle@ph.ed.ac.uk> | ||||
| Author: Peter Boyle <peterboyle@Peters-MacBook-Pro-2.local> | ||||
| Author: paboyle <paboyle@ph.ed.ac.uk> | ||||
| Author: Nils Meyer <nils.meyer@ur.de> Regensburg University | ||||
|  | ||||
| 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 | ||||
| the Free Software Foundation; either version 2 of the License, or | ||||
| (at your option) any later version. | ||||
|  | ||||
| This program is distributed in the hope that it will be useful, | ||||
| but WITHOUT ANY WARRANTY; without even the implied warranty of | ||||
| MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE.  See the | ||||
| GNU General Public License for more details. | ||||
|  | ||||
| You should have received a copy of the GNU General Public License along | ||||
| with this program; if not, write to the Free Software Foundation, Inc., | ||||
| 51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. | ||||
|  | ||||
| See the full license in the file "LICENSE" in the top level distribution | ||||
| directory | ||||
| *************************************************************************************/ | ||||
| /*  END LEGAL */ | ||||
| #include <Grid/qcd/action/fermion/FermionCore.h> | ||||
| #include <Grid/qcd/action/fermion/implementation/WilsonKernelsImplementation.h> | ||||
| #include <Grid/qcd/action/fermion/implementation/WilsonKernelsHandImplementation.h> | ||||
|  | ||||
| #ifndef AVX512 | ||||
| #ifndef QPX | ||||
| #ifndef A64FX | ||||
| #ifndef A64FXFIXEDSIZE | ||||
| #include <Grid/qcd/action/fermion/implementation/WilsonKernelsAsmImplementation.h> | ||||
| #endif | ||||
| #endif | ||||
| #endif | ||||
| #endif | ||||
|  | ||||
| NAMESPACE_BEGIN(Grid); | ||||
|  | ||||
| #include "impl.h" | ||||
| template class WilsonKernels<IMPLEMENTATION>; | ||||
|  | ||||
| NAMESPACE_END(Grid); | ||||
| @@ -0,0 +1 @@ | ||||
| ../WilsonKernelsInstantiation.cc.master | ||||
| @@ -32,6 +32,7 @@ directory | ||||
| #include <Grid/qcd/action/fermion/FermionCore.h> | ||||
| #include <Grid/qcd/action/fermion/implementation/WilsonKernelsImplementation.h> | ||||
| #include <Grid/qcd/action/fermion/implementation/WilsonKernelsHandImplementation.h> | ||||
| #include <Grid/qcd/action/fermion/implementation/WilsonKernelsHandImplementationSycl.h> | ||||
|  | ||||
| #ifndef AVX512 | ||||
| #ifndef QPX | ||||
|   | ||||
| @@ -1,51 +0,0 @@ | ||||
| /************************************************************************************* | ||||
|  | ||||
| Grid physics library, www.github.com/paboyle/Grid | ||||
|  | ||||
| Source file: ./lib/qcd/action/fermion/WilsonKernels.cc | ||||
|  | ||||
| Copyright (C) 2015, 2020 | ||||
|  | ||||
| Author: Peter Boyle <paboyle@ph.ed.ac.uk> | ||||
| Author: Peter Boyle <peterboyle@Peters-MacBook-Pro-2.local> | ||||
| Author: paboyle <paboyle@ph.ed.ac.uk> | ||||
| Author: Nils Meyer <nils.meyer@ur.de> Regensburg University | ||||
|  | ||||
| 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 | ||||
| the Free Software Foundation; either version 2 of the License, or | ||||
| (at your option) any later version. | ||||
|  | ||||
| This program is distributed in the hope that it will be useful, | ||||
| but WITHOUT ANY WARRANTY; without even the implied warranty of | ||||
| MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE.  See the | ||||
| GNU General Public License for more details. | ||||
|  | ||||
| You should have received a copy of the GNU General Public License along | ||||
| with this program; if not, write to the Free Software Foundation, Inc., | ||||
| 51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. | ||||
|  | ||||
| See the full license in the file "LICENSE" in the top level distribution | ||||
| directory | ||||
| *************************************************************************************/ | ||||
| /*  END LEGAL */ | ||||
| #include <Grid/qcd/action/fermion/FermionCore.h> | ||||
| #include <Grid/qcd/action/fermion/implementation/WilsonKernelsImplementation.h> | ||||
| #include <Grid/qcd/action/fermion/implementation/WilsonKernelsHandImplementation.h> | ||||
|  | ||||
| #ifndef AVX512 | ||||
| #ifndef QPX | ||||
| #ifndef A64FX | ||||
| #ifndef A64FXFIXEDSIZE | ||||
| #include <Grid/qcd/action/fermion/implementation/WilsonKernelsAsmImplementation.h> | ||||
| #endif | ||||
| #endif | ||||
| #endif | ||||
| #endif | ||||
|  | ||||
| NAMESPACE_BEGIN(Grid); | ||||
|  | ||||
| #include "impl.h" | ||||
| template class WilsonKernels<IMPLEMENTATION>; | ||||
|  | ||||
| NAMESPACE_END(Grid); | ||||
| @@ -0,0 +1 @@ | ||||
| ../WilsonKernelsInstantiation.cc.master | ||||
| @@ -1,51 +0,0 @@ | ||||
| /************************************************************************************* | ||||
|  | ||||
| Grid physics library, www.github.com/paboyle/Grid | ||||
|  | ||||
| Source file: ./lib/qcd/action/fermion/WilsonKernels.cc | ||||
|  | ||||
| Copyright (C) 2015, 2020 | ||||
|  | ||||
| Author: Peter Boyle <paboyle@ph.ed.ac.uk> | ||||
| Author: Peter Boyle <peterboyle@Peters-MacBook-Pro-2.local> | ||||
| Author: paboyle <paboyle@ph.ed.ac.uk> | ||||
| Author: Nils Meyer <nils.meyer@ur.de> Regensburg University | ||||
|  | ||||
| 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 | ||||
| the Free Software Foundation; either version 2 of the License, or | ||||
| (at your option) any later version. | ||||
|  | ||||
| This program is distributed in the hope that it will be useful, | ||||
| but WITHOUT ANY WARRANTY; without even the implied warranty of | ||||
| MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE.  See the | ||||
| GNU General Public License for more details. | ||||
|  | ||||
| You should have received a copy of the GNU General Public License along | ||||
| with this program; if not, write to the Free Software Foundation, Inc., | ||||
| 51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. | ||||
|  | ||||
| See the full license in the file "LICENSE" in the top level distribution | ||||
| directory | ||||
| *************************************************************************************/ | ||||
| /*  END LEGAL */ | ||||
| #include <Grid/qcd/action/fermion/FermionCore.h> | ||||
| #include <Grid/qcd/action/fermion/implementation/WilsonKernelsImplementation.h> | ||||
| #include <Grid/qcd/action/fermion/implementation/WilsonKernelsHandImplementation.h> | ||||
|  | ||||
| #ifndef AVX512 | ||||
| #ifndef QPX | ||||
| #ifndef A64FX | ||||
| #ifndef A64FXFIXEDSIZE | ||||
| #include <Grid/qcd/action/fermion/implementation/WilsonKernelsAsmImplementation.h> | ||||
| #endif | ||||
| #endif | ||||
| #endif | ||||
| #endif | ||||
|  | ||||
| NAMESPACE_BEGIN(Grid); | ||||
|  | ||||
| #include "impl.h" | ||||
| template class WilsonKernels<IMPLEMENTATION>; | ||||
|  | ||||
| NAMESPACE_END(Grid); | ||||
| @@ -0,0 +1 @@ | ||||
| ../WilsonKernelsInstantiation.cc.master | ||||
| @@ -1,51 +0,0 @@ | ||||
| /************************************************************************************* | ||||
|  | ||||
| Grid physics library, www.github.com/paboyle/Grid | ||||
|  | ||||
| Source file: ./lib/qcd/action/fermion/WilsonKernels.cc | ||||
|  | ||||
| Copyright (C) 2015, 2020 | ||||
|  | ||||
| Author: Peter Boyle <paboyle@ph.ed.ac.uk> | ||||
| Author: Peter Boyle <peterboyle@Peters-MacBook-Pro-2.local> | ||||
| Author: paboyle <paboyle@ph.ed.ac.uk> | ||||
| Author: Nils Meyer <nils.meyer@ur.de> Regensburg University | ||||
|  | ||||
| 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 | ||||
| the Free Software Foundation; either version 2 of the License, or | ||||
| (at your option) any later version. | ||||
|  | ||||
| This program is distributed in the hope that it will be useful, | ||||
| but WITHOUT ANY WARRANTY; without even the implied warranty of | ||||
| MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE.  See the | ||||
| GNU General Public License for more details. | ||||
|  | ||||
| You should have received a copy of the GNU General Public License along | ||||
| with this program; if not, write to the Free Software Foundation, Inc., | ||||
| 51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. | ||||
|  | ||||
| See the full license in the file "LICENSE" in the top level distribution | ||||
| directory | ||||
| *************************************************************************************/ | ||||
| /*  END LEGAL */ | ||||
| #include <Grid/qcd/action/fermion/FermionCore.h> | ||||
| #include <Grid/qcd/action/fermion/implementation/WilsonKernelsImplementation.h> | ||||
| #include <Grid/qcd/action/fermion/implementation/WilsonKernelsHandImplementation.h> | ||||
|  | ||||
| #ifndef AVX512 | ||||
| #ifndef QPX | ||||
| #ifndef A64FX | ||||
| #ifndef A64FXFIXEDSIZE | ||||
| #include <Grid/qcd/action/fermion/implementation/WilsonKernelsAsmImplementation.h> | ||||
| #endif | ||||
| #endif | ||||
| #endif | ||||
| #endif | ||||
|  | ||||
| NAMESPACE_BEGIN(Grid); | ||||
|  | ||||
| #include "impl.h" | ||||
| template class WilsonKernels<IMPLEMENTATION>; | ||||
|  | ||||
| NAMESPACE_END(Grid); | ||||
| @@ -0,0 +1 @@ | ||||
| ../WilsonKernelsInstantiation.cc.master | ||||
| @@ -1,51 +0,0 @@ | ||||
| /************************************************************************************* | ||||
|  | ||||
| Grid physics library, www.github.com/paboyle/Grid | ||||
|  | ||||
| Source file: ./lib/qcd/action/fermion/WilsonKernels.cc | ||||
|  | ||||
| Copyright (C) 2015, 2020 | ||||
|  | ||||
| Author: Peter Boyle <paboyle@ph.ed.ac.uk> | ||||
| Author: Peter Boyle <peterboyle@Peters-MacBook-Pro-2.local> | ||||
| Author: paboyle <paboyle@ph.ed.ac.uk> | ||||
| Author: Nils Meyer <nils.meyer@ur.de> Regensburg University | ||||
|  | ||||
| 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 | ||||
| the Free Software Foundation; either version 2 of the License, or | ||||
| (at your option) any later version. | ||||
|  | ||||
| This program is distributed in the hope that it will be useful, | ||||
| but WITHOUT ANY WARRANTY; without even the implied warranty of | ||||
| MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE.  See the | ||||
| GNU General Public License for more details. | ||||
|  | ||||
| You should have received a copy of the GNU General Public License along | ||||
| with this program; if not, write to the Free Software Foundation, Inc., | ||||
| 51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. | ||||
|  | ||||
| See the full license in the file "LICENSE" in the top level distribution | ||||
| directory | ||||
| *************************************************************************************/ | ||||
| /*  END LEGAL */ | ||||
| #include <Grid/qcd/action/fermion/FermionCore.h> | ||||
| #include <Grid/qcd/action/fermion/implementation/WilsonKernelsImplementation.h> | ||||
| #include <Grid/qcd/action/fermion/implementation/WilsonKernelsHandImplementation.h> | ||||
|  | ||||
| #ifndef AVX512 | ||||
| #ifndef QPX | ||||
| #ifndef A64FX | ||||
| #ifndef A64FXFIXEDSIZE | ||||
| #include <Grid/qcd/action/fermion/implementation/WilsonKernelsAsmImplementation.h> | ||||
| #endif | ||||
| #endif | ||||
| #endif | ||||
| #endif | ||||
|  | ||||
| NAMESPACE_BEGIN(Grid); | ||||
|  | ||||
| #include "impl.h" | ||||
| template class WilsonKernels<IMPLEMENTATION>; | ||||
|  | ||||
| NAMESPACE_END(Grid); | ||||
| @@ -0,0 +1 @@ | ||||
| ../WilsonKernelsInstantiation.cc.master | ||||
| @@ -1,51 +0,0 @@ | ||||
| /************************************************************************************* | ||||
|  | ||||
| Grid physics library, www.github.com/paboyle/Grid | ||||
|  | ||||
| Source file: ./lib/qcd/action/fermion/WilsonKernels.cc | ||||
|  | ||||
| Copyright (C) 2015, 2020 | ||||
|  | ||||
| Author: Peter Boyle <paboyle@ph.ed.ac.uk> | ||||
| Author: Peter Boyle <peterboyle@Peters-MacBook-Pro-2.local> | ||||
| Author: paboyle <paboyle@ph.ed.ac.uk> | ||||
| Author: Nils Meyer <nils.meyer@ur.de> Regensburg University | ||||
|  | ||||
| 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 | ||||
| the Free Software Foundation; either version 2 of the License, or | ||||
| (at your option) any later version. | ||||
|  | ||||
| This program is distributed in the hope that it will be useful, | ||||
| but WITHOUT ANY WARRANTY; without even the implied warranty of | ||||
| MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE.  See the | ||||
| GNU General Public License for more details. | ||||
|  | ||||
| You should have received a copy of the GNU General Public License along | ||||
| with this program; if not, write to the Free Software Foundation, Inc., | ||||
| 51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. | ||||
|  | ||||
| See the full license in the file "LICENSE" in the top level distribution | ||||
| directory | ||||
| *************************************************************************************/ | ||||
| /*  END LEGAL */ | ||||
| #include <Grid/qcd/action/fermion/FermionCore.h> | ||||
| #include <Grid/qcd/action/fermion/implementation/WilsonKernelsImplementation.h> | ||||
| #include <Grid/qcd/action/fermion/implementation/WilsonKernelsHandImplementation.h> | ||||
|  | ||||
| #ifndef AVX512 | ||||
| #ifndef QPX | ||||
| #ifndef A64FX | ||||
| #ifndef A64FXFIXEDSIZE | ||||
| #include <Grid/qcd/action/fermion/implementation/WilsonKernelsAsmImplementation.h> | ||||
| #endif | ||||
| #endif | ||||
| #endif | ||||
| #endif | ||||
|  | ||||
| NAMESPACE_BEGIN(Grid); | ||||
|  | ||||
| #include "impl.h" | ||||
| template class WilsonKernels<IMPLEMENTATION>; | ||||
|  | ||||
| NAMESPACE_END(Grid); | ||||
| @@ -0,0 +1 @@ | ||||
| ../WilsonKernelsInstantiation.cc.master | ||||
| @@ -1,51 +0,0 @@ | ||||
| /************************************************************************************* | ||||
|  | ||||
| Grid physics library, www.github.com/paboyle/Grid | ||||
|  | ||||
| Source file: ./lib/qcd/action/fermion/WilsonKernels.cc | ||||
|  | ||||
| Copyright (C) 2015, 2020 | ||||
|  | ||||
| Author: Peter Boyle <paboyle@ph.ed.ac.uk> | ||||
| Author: Peter Boyle <peterboyle@Peters-MacBook-Pro-2.local> | ||||
| Author: paboyle <paboyle@ph.ed.ac.uk> | ||||
| Author: Nils Meyer <nils.meyer@ur.de> Regensburg University | ||||
|  | ||||
| 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 | ||||
| the Free Software Foundation; either version 2 of the License, or | ||||
| (at your option) any later version. | ||||
|  | ||||
| This program is distributed in the hope that it will be useful, | ||||
| but WITHOUT ANY WARRANTY; without even the implied warranty of | ||||
| MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE.  See the | ||||
| GNU General Public License for more details. | ||||
|  | ||||
| You should have received a copy of the GNU General Public License along | ||||
| with this program; if not, write to the Free Software Foundation, Inc., | ||||
| 51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. | ||||
|  | ||||
| See the full license in the file "LICENSE" in the top level distribution | ||||
| directory | ||||
| *************************************************************************************/ | ||||
| /*  END LEGAL */ | ||||
| #include <Grid/qcd/action/fermion/FermionCore.h> | ||||
| #include <Grid/qcd/action/fermion/implementation/WilsonKernelsImplementation.h> | ||||
| #include <Grid/qcd/action/fermion/implementation/WilsonKernelsHandImplementation.h> | ||||
|  | ||||
| #ifndef AVX512 | ||||
| #ifndef QPX | ||||
| #ifndef A64FX | ||||
| #ifndef A64FXFIXEDSIZE | ||||
| #include <Grid/qcd/action/fermion/implementation/WilsonKernelsAsmImplementation.h> | ||||
| #endif | ||||
| #endif | ||||
| #endif | ||||
| #endif | ||||
|  | ||||
| NAMESPACE_BEGIN(Grid); | ||||
|  | ||||
| #include "impl.h" | ||||
| template class WilsonKernels<IMPLEMENTATION>; | ||||
|  | ||||
| NAMESPACE_END(Grid); | ||||
| @@ -0,0 +1 @@ | ||||
| ../WilsonKernelsInstantiation.cc.master | ||||
| @@ -1,51 +0,0 @@ | ||||
| /************************************************************************************* | ||||
|  | ||||
| Grid physics library, www.github.com/paboyle/Grid | ||||
|  | ||||
| Source file: ./lib/qcd/action/fermion/WilsonKernels.cc | ||||
|  | ||||
| Copyright (C) 2015, 2020 | ||||
|  | ||||
| Author: Peter Boyle <paboyle@ph.ed.ac.uk> | ||||
| Author: Peter Boyle <peterboyle@Peters-MacBook-Pro-2.local> | ||||
| Author: paboyle <paboyle@ph.ed.ac.uk> | ||||
| Author: Nils Meyer <nils.meyer@ur.de> Regensburg University | ||||
|  | ||||
| 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 | ||||
| the Free Software Foundation; either version 2 of the License, or | ||||
| (at your option) any later version. | ||||
|  | ||||
| This program is distributed in the hope that it will be useful, | ||||
| but WITHOUT ANY WARRANTY; without even the implied warranty of | ||||
| MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE.  See the | ||||
| GNU General Public License for more details. | ||||
|  | ||||
| You should have received a copy of the GNU General Public License along | ||||
| with this program; if not, write to the Free Software Foundation, Inc., | ||||
| 51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. | ||||
|  | ||||
| See the full license in the file "LICENSE" in the top level distribution | ||||
| directory | ||||
| *************************************************************************************/ | ||||
| /*  END LEGAL */ | ||||
| #include <Grid/qcd/action/fermion/FermionCore.h> | ||||
| #include <Grid/qcd/action/fermion/implementation/WilsonKernelsImplementation.h> | ||||
| #include <Grid/qcd/action/fermion/implementation/WilsonKernelsHandImplementation.h> | ||||
|  | ||||
| #ifndef AVX512 | ||||
| #ifndef QPX | ||||
| #ifndef A64FX | ||||
| #ifndef A64FXFIXEDSIZE | ||||
| #include <Grid/qcd/action/fermion/implementation/WilsonKernelsAsmImplementation.h> | ||||
| #endif | ||||
| #endif | ||||
| #endif | ||||
| #endif | ||||
|  | ||||
| NAMESPACE_BEGIN(Grid); | ||||
|  | ||||
| #include "impl.h" | ||||
| template class WilsonKernels<IMPLEMENTATION>; | ||||
|  | ||||
| NAMESPACE_END(Grid); | ||||
| @@ -0,0 +1 @@ | ||||
| ../WilsonKernelsInstantiation.cc.master | ||||
| @@ -1,51 +0,0 @@ | ||||
| /************************************************************************************* | ||||
|  | ||||
| Grid physics library, www.github.com/paboyle/Grid | ||||
|  | ||||
| Source file: ./lib/qcd/action/fermion/WilsonKernels.cc | ||||
|  | ||||
| Copyright (C) 2015, 2020 | ||||
|  | ||||
| Author: Peter Boyle <paboyle@ph.ed.ac.uk> | ||||
| Author: Peter Boyle <peterboyle@Peters-MacBook-Pro-2.local> | ||||
| Author: paboyle <paboyle@ph.ed.ac.uk> | ||||
| Author: Nils Meyer <nils.meyer@ur.de> Regensburg University | ||||
|  | ||||
| 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 | ||||
| the Free Software Foundation; either version 2 of the License, or | ||||
| (at your option) any later version. | ||||
|  | ||||
| This program is distributed in the hope that it will be useful, | ||||
| but WITHOUT ANY WARRANTY; without even the implied warranty of | ||||
| MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE.  See the | ||||
| GNU General Public License for more details. | ||||
|  | ||||
| You should have received a copy of the GNU General Public License along | ||||
| with this program; if not, write to the Free Software Foundation, Inc., | ||||
| 51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. | ||||
|  | ||||
| See the full license in the file "LICENSE" in the top level distribution | ||||
| directory | ||||
| *************************************************************************************/ | ||||
| /*  END LEGAL */ | ||||
| #include <Grid/qcd/action/fermion/FermionCore.h> | ||||
| #include <Grid/qcd/action/fermion/implementation/WilsonKernelsImplementation.h> | ||||
| #include <Grid/qcd/action/fermion/implementation/WilsonKernelsHandImplementation.h> | ||||
|  | ||||
| #ifndef AVX512 | ||||
| #ifndef QPX | ||||
| #ifndef A64FX | ||||
| #ifndef A64FXFIXEDSIZE | ||||
| #include <Grid/qcd/action/fermion/implementation/WilsonKernelsAsmImplementation.h> | ||||
| #endif | ||||
| #endif | ||||
| #endif | ||||
| #endif | ||||
|  | ||||
| NAMESPACE_BEGIN(Grid); | ||||
|  | ||||
| #include "impl.h" | ||||
| template class WilsonKernels<IMPLEMENTATION>; | ||||
|  | ||||
| NAMESPACE_END(Grid); | ||||
| @@ -0,0 +1 @@ | ||||
| ../WilsonKernelsInstantiation.cc.master | ||||
| @@ -96,7 +96,7 @@ public: | ||||
|   /////////////////////////////////////////////////////////// | ||||
|   // Move these to another class | ||||
|   // HMC auxiliary functions | ||||
|   static inline void generate_momenta(Field &P, GridSerialRNG & sRNG, GridParallelRNG &pRNG)  | ||||
|   static inline void generate_momenta(Field &P, GridParallelRNG &pRNG)  | ||||
|   { | ||||
|     // Zbigniew Srocinsky thesis: | ||||
|     // | ||||
|   | ||||
| @@ -49,7 +49,7 @@ public: | ||||
|  | ||||
|   virtual std::string action_name(){return "PlaqPlusRectangleAction";} | ||||
|        | ||||
|   virtual void refresh(const GaugeField &U, GridSerialRNG &sRNG, GridParallelRNG& pRNG) {}; // noop as no pseudoferms | ||||
|   virtual void refresh(const GaugeField &U, GridParallelRNG& pRNG) {}; // noop as no pseudoferms | ||||
|        | ||||
|   virtual std::string LogParameters(){ | ||||
|     std::stringstream sstream; | ||||
|   | ||||
| @@ -54,7 +54,8 @@ public: | ||||
|     return sstream.str(); | ||||
|   } | ||||
|  | ||||
|   virtual void refresh(const GaugeField &U, GridSerialRNG &sRNG, GridParallelRNG &pRNG){};  // noop as no pseudoferms | ||||
|   virtual void refresh(const GaugeField &U, | ||||
|                        GridParallelRNG &pRNG){};  // noop as no pseudoferms | ||||
|  | ||||
|   virtual RealD S(const GaugeField &U) { | ||||
|     RealD plaq = WilsonLoops<Gimpl>::avgPlaquette(U); | ||||
|   | ||||
| @@ -124,7 +124,7 @@ NAMESPACE_BEGIN(Grid); | ||||
|       // | ||||
|       // As a check of rational require \Phi^dag M_{EOFA} \Phi == eta^dag M^-1/2^dag M M^-1/2 eta = eta^dag eta | ||||
|       // | ||||
|       virtual void refresh(const GaugeField& U, GridSerialRNG &sRNG, GridParallelRNG& pRNG) | ||||
|       virtual void refresh(const GaugeField& U, GridParallelRNG& pRNG) | ||||
|       { | ||||
|         Lop.ImportGauge(U); | ||||
|         Rop.ImportGauge(U); | ||||
|   | ||||
| @@ -1,3 +1,4 @@ | ||||
|  | ||||
| /************************************************************************************* | ||||
|  | ||||
| Grid physics library, www.github.com/paboyle/Grid | ||||
| @@ -42,7 +43,8 @@ NAMESPACE_BEGIN(Grid); | ||||
| // | ||||
|  | ||||
| template <class Impl> | ||||
| class OneFlavourEvenOddRationalPseudoFermionAction : public Action<typename Impl::GaugeField> { | ||||
| class OneFlavourEvenOddRationalPseudoFermionAction | ||||
|   : public Action<typename Impl::GaugeField> { | ||||
| public: | ||||
|   INHERIT_IMPL_TYPES(Impl); | ||||
|  | ||||
| @@ -101,7 +103,7 @@ public: | ||||
|     return sstream.str(); | ||||
|   } | ||||
|    | ||||
|   virtual void refresh(const GaugeField &U, GridSerialRNG &sRNG, GridParallelRNG &pRNG) { | ||||
|   virtual void refresh(const GaugeField &U, GridParallelRNG &pRNG) { | ||||
|     // P(phi) = e^{- phi^dag (MpcdagMpc)^-1/2 phi} | ||||
|     //        = e^{- phi^dag (MpcdagMpc)^-1/4 (MpcdagMpc)^-1/4 phi} | ||||
|     // Phi = MpcdagMpc^{1/4} eta | ||||
| @@ -154,10 +156,7 @@ public: | ||||
|  | ||||
|     msCG(Mpc, PhiOdd, Y); | ||||
|  | ||||
|     auto grid = FermOp.FermionGrid(); | ||||
|     auto r=rand(); | ||||
|     grid->Broadcast(0,r); | ||||
|     if ( (r%param.BoundsCheckFreq)==0 ) {  | ||||
|     if ( (rand()%param.BoundsCheckFreq)==0 ) {  | ||||
|       FermionField gauss(FermOp.FermionRedBlackGrid()); | ||||
|       gauss = PhiOdd; | ||||
|       HighBoundCheck(Mpc,gauss,param.hi); | ||||
|   | ||||
| @@ -101,7 +101,7 @@ NAMESPACE_BEGIN(Grid); | ||||
|       } | ||||
|        | ||||
|        | ||||
|       virtual void refresh(const GaugeField &U, GridSerialRNG &sRNG, GridParallelRNG& pRNG) { | ||||
|       virtual void refresh(const GaugeField &U, GridParallelRNG& pRNG) { | ||||
|  | ||||
| 	// S_f = chi^dag* P(V^dag*V)/Q(V^dag*V)* N(M^dag*M)/D(M^dag*M)* P(V^dag*V)/Q(V^dag*V)* chi        | ||||
| 	// | ||||
| @@ -170,10 +170,7 @@ NAMESPACE_BEGIN(Grid); | ||||
| 	msCG_M(MdagM,X,Y); | ||||
|  | ||||
| 	// Randomly apply rational bounds checks. | ||||
| 	auto grid = NumOp.FermionGrid(); | ||||
|         auto r=rand(); | ||||
|         grid->Broadcast(0,r); | ||||
|         if ( (r%param.BoundsCheckFreq)==0 ) {  | ||||
| 	if ( (rand()%param.BoundsCheckFreq)==0 ) {  | ||||
| 	  FermionField gauss(NumOp.FermionRedBlackGrid()); | ||||
| 	  gauss = PhiOdd; | ||||
| 	  HighBoundCheck(MdagM,gauss,param.hi); | ||||
|   | ||||
| @@ -98,7 +98,7 @@ NAMESPACE_BEGIN(Grid); | ||||
|  | ||||
|  | ||||
|        | ||||
|       virtual void refresh(const GaugeField &U, GridSerialRNG &sRNG, GridParallelRNG& pRNG) { | ||||
|       virtual void refresh(const GaugeField &U, GridParallelRNG& pRNG) { | ||||
|  | ||||
| 	 | ||||
| 	// P(phi) = e^{- phi^dag (MdagM)^-1/2 phi} | ||||
| @@ -142,10 +142,7 @@ NAMESPACE_BEGIN(Grid); | ||||
|  | ||||
| 	msCG(MdagMOp,Phi,Y); | ||||
|  | ||||
| 	auto grid = FermOp.FermionGrid(); | ||||
|         auto r=rand(); | ||||
|         grid->Broadcast(0,r); | ||||
|         if ( (r%param.BoundsCheckFreq)==0 ) {  | ||||
| 	if ( (rand()%param.BoundsCheckFreq)==0 ) {  | ||||
| 	  FermionField gauss(FermOp.FermionGrid()); | ||||
| 	  gauss = Phi; | ||||
| 	  HighBoundCheck(MdagMOp,gauss,param.hi); | ||||
|   | ||||
| @@ -95,7 +95,7 @@ NAMESPACE_BEGIN(Grid); | ||||
|       } | ||||
|        | ||||
|  | ||||
|       virtual void refresh(const GaugeField &U, GridSerialRNG &sRNG, GridParallelRNG& pRNG) { | ||||
|       virtual void refresh(const GaugeField &U, GridParallelRNG& pRNG) { | ||||
|  | ||||
| 	// S_f = chi^dag* P(V^dag*V)/Q(V^dag*V)* N(M^dag*M)/D(M^dag*M)* P(V^dag*V)/Q(V^dag*V)* chi        | ||||
| 	// | ||||
| @@ -156,10 +156,7 @@ NAMESPACE_BEGIN(Grid); | ||||
| 	msCG_M(MdagM,X,Y); | ||||
|  | ||||
| 	// Randomly apply rational bounds checks. | ||||
|         auto grid = NumOp.FermionGrid(); | ||||
|         auto r=rand(); | ||||
|         grid->Broadcast(0,r); | ||||
|         if ( (r%param.BoundsCheckFreq)==0 ) { 	 | ||||
| 	if ( (rand()%param.BoundsCheckFreq)==0 ) {  | ||||
| 	  FermionField gauss(NumOp.FermionGrid()); | ||||
| 	  gauss = Phi; | ||||
| 	  HighBoundCheck(MdagM,gauss,param.hi); | ||||
|   | ||||
| @@ -73,7 +73,7 @@ public: | ||||
|   ////////////////////////////////////////////////////////////////////////////////////// | ||||
|   // Push the gauge field in to the dops. Assume any BC's and smearing already applied | ||||
|   ////////////////////////////////////////////////////////////////////////////////////// | ||||
|   virtual void refresh(const GaugeField &U, GridSerialRNG &sRNG, GridParallelRNG &pRNG) { | ||||
|   virtual void refresh(const GaugeField &U, GridParallelRNG &pRNG) { | ||||
|     // P(phi) = e^{- phi^dag (MdagM)^-1 phi} | ||||
|     // Phi = Mdag eta | ||||
|     // P(eta) = e^{- eta^dag eta} | ||||
|   | ||||
| @@ -77,7 +77,7 @@ public: | ||||
|   ////////////////////////////////////////////////////////////////////////////////////// | ||||
|   // Push the gauge field in to the dops. Assume any BC's and smearing already applied | ||||
|   ////////////////////////////////////////////////////////////////////////////////////// | ||||
|   virtual void refresh(const GaugeField &U, GridSerialRNG &sRNG, GridParallelRNG& pRNG) { | ||||
|   virtual void refresh(const GaugeField &U, GridParallelRNG& pRNG) { | ||||
|      | ||||
|     // P(phi) = e^{- phi^dag (MpcdagMpc)^-1 phi} | ||||
|     // Phi = McpDag eta  | ||||
|   | ||||
| @@ -84,7 +84,7 @@ NAMESPACE_BEGIN(Grid); | ||||
|       }  | ||||
|  | ||||
|        | ||||
|       virtual void refresh(const GaugeField &U, GridSerialRNG &sRNG, GridParallelRNG& pRNG) { | ||||
|       virtual void refresh(const GaugeField &U, GridParallelRNG& pRNG) { | ||||
|  | ||||
|         // P(phi) = e^{- phi^dag Vpc (MpcdagMpc)^-1 Vpcdag phi} | ||||
|         // | ||||
|   | ||||
| @@ -64,7 +64,7 @@ public: | ||||
|     return sstream.str(); | ||||
|   }   | ||||
|        | ||||
|   virtual void refresh(const GaugeField &U, GridSerialRNG &sRNG, GridParallelRNG& pRNG) { | ||||
|   virtual void refresh(const GaugeField &U, GridParallelRNG& pRNG) { | ||||
|  | ||||
|     // P(phi) = e^{- phi^dag V (MdagM)^-1 Vdag phi} | ||||
|     // | ||||
|   | ||||
| @@ -55,7 +55,7 @@ public: | ||||
|   } | ||||
|   virtual std::string action_name() {return "ScalarAction";} | ||||
|  | ||||
|   virtual void refresh(const Field &U, GridSerialRNG &sRNG, GridParallelRNG &pRNG) {}  // noop as no pseudoferms | ||||
|   virtual void refresh(const Field &U, GridParallelRNG &pRNG) {}  // noop as no pseudoferms | ||||
|  | ||||
|   virtual RealD S(const Field &p) { | ||||
|     return (mass_square * 0.5 + Nd) * ScalarObs<Impl>::sumphisquared(p) + | ||||
|   | ||||
| @@ -27,7 +27,7 @@ public: | ||||
|   typedef Field              FermionField; | ||||
|   typedef Field              PropagatorField; | ||||
|      | ||||
|   static inline void generate_momenta(Field& P, GridSerialRNG &sRNG, GridParallelRNG& pRNG){ | ||||
|   static inline void generate_momenta(Field& P, GridParallelRNG& pRNG){ | ||||
|     RealD scale = ::sqrt(HMC_MOMENTUM_DENOMINATOR); // CPS/UKQCD momentum rescaling | ||||
|     gaussian(pRNG, P); | ||||
|     P *= scale;  | ||||
| @@ -151,7 +151,7 @@ public: | ||||
|       out = one / out; | ||||
|     } | ||||
|  | ||||
|     static inline void generate_momenta(Field &P, GridSerialRNG & sRNG, GridParallelRNG &pRNG) | ||||
|     static inline void generate_momenta(Field &P, GridParallelRNG &pRNG) | ||||
|     { | ||||
|       RealD scale = ::sqrt(HMC_MOMENTUM_DENOMINATOR); // CPS/UKQCD momentum rescaling | ||||
| #ifndef USE_FFT_ACCELERATION | ||||
|   | ||||
| @@ -77,7 +77,7 @@ public: | ||||
|  | ||||
|   virtual std::string action_name() { return "ScalarAction"; } | ||||
|  | ||||
|   virtual void refresh(const Field &U, GridSerialRNG & sRNG, GridParallelRNG &pRNG) {} | ||||
|   virtual void refresh(const Field &U, GridParallelRNG &pRNG) {} | ||||
|  | ||||
|   virtual RealD S(const Field &p) | ||||
|   { | ||||
|   | ||||
| @@ -139,7 +139,7 @@ private: | ||||
|   // Evolution | ||||
|   ///////////////////////////////////////////////////////// | ||||
|   RealD evolve_hmc_step(Field &U) { | ||||
|     TheIntegrator.refresh(U, sRNG, pRNG);  // set U and initialize P and phi's | ||||
|     TheIntegrator.refresh(U, pRNG);  // set U and initialize P and phi's | ||||
|  | ||||
|     RealD H0 = TheIntegrator.S(U);  // initial state action | ||||
|  | ||||
|   | ||||
| @@ -33,7 +33,6 @@ directory | ||||
| #define INTEGRATOR_INCLUDED | ||||
|  | ||||
| #include <memory> | ||||
| #include "MomentumFilter.h" | ||||
|  | ||||
| NAMESPACE_BEGIN(Grid); | ||||
|  | ||||
| @@ -79,19 +78,8 @@ protected: | ||||
|   RepresentationPolicy Representations; | ||||
|   IntegratorParameters Params; | ||||
|  | ||||
|   //Filters allow the user to manipulate the conjugate momentum, for example to freeze links in DDHMC | ||||
|   //It is applied whenever the momentum is updated / refreshed | ||||
|   //The default filter does nothing | ||||
|   MomentumFilterBase<MomentaField> const* MomFilter; | ||||
|  | ||||
|   const ActionSet<Field, RepresentationPolicy> as; | ||||
|  | ||||
|   //Get a pointer to a shared static instance of the "do-nothing" momentum filter to serve as a default | ||||
|   static MomentumFilterBase<MomentaField> const* getDefaultMomFilter(){  | ||||
|     static MomentumFilterNone<MomentaField> filter; | ||||
|     return &filter; | ||||
|   } | ||||
|  | ||||
|   void update_P(Field& U, int level, double ep)  | ||||
|   { | ||||
|     t_P[level] += ep; | ||||
| @@ -147,8 +135,6 @@ protected: | ||||
|  | ||||
|     // Force from the other representations | ||||
|     as[level].apply(update_P_hireps, Representations, Mom, U, ep); | ||||
|  | ||||
|     MomFilter->applyFilter(Mom); | ||||
|   } | ||||
|  | ||||
|   void update_U(Field& U, double ep)  | ||||
| @@ -188,24 +174,12 @@ public: | ||||
|     t_P.resize(levels, 0.0); | ||||
|     t_U = 0.0; | ||||
|     // initialization of smearer delegated outside of Integrator | ||||
|  | ||||
|     //Default the momentum filter to "do-nothing" | ||||
|     MomFilter = getDefaultMomFilter(); | ||||
|   }; | ||||
|  | ||||
|   virtual ~Integrator() {} | ||||
|  | ||||
|   virtual std::string integrator_name() = 0; | ||||
|  | ||||
|   //Set the momentum filter allowing for manipulation of the conjugate momentum | ||||
|   void setMomentumFilter(const MomentumFilterBase<MomentaField> &filter){ | ||||
|     MomFilter = &filter; | ||||
|   } | ||||
|  | ||||
|   //Access the conjugate momentum | ||||
|   const MomentaField & getMomentum() const{ return P; } | ||||
|    | ||||
|  | ||||
|   void print_parameters() | ||||
|   { | ||||
|     std::cout << GridLogMessage << "[Integrator] Name : "<< integrator_name() << std::endl; | ||||
| @@ -236,9 +210,10 @@ public: | ||||
|   // over the representations | ||||
|   struct _refresh { | ||||
|     template <class FieldType, class Repr> | ||||
|     void operator()(std::vector<Action<FieldType>*> repr_set, Repr& Rep, GridSerialRNG & sRNG, GridParallelRNG& pRNG) { | ||||
|     void operator()(std::vector<Action<FieldType>*> repr_set, Repr& Rep, | ||||
|                     GridParallelRNG& pRNG) { | ||||
|       for (int a = 0; a < repr_set.size(); ++a){ | ||||
|         repr_set.at(a)->refresh(Rep.U, sRNG, pRNG); | ||||
|         repr_set.at(a)->refresh(Rep.U, pRNG); | ||||
|        | ||||
| 	std::cout << GridLogDebug << "Hirep refreshing pseudofermions" << std::endl; | ||||
|       } | ||||
| @@ -246,12 +221,12 @@ public: | ||||
|   } refresh_hireps{}; | ||||
|  | ||||
|   // Initialization of momenta and actions | ||||
|   void refresh(Field& U,  GridSerialRNG & sRNG, GridParallelRNG& pRNG)  | ||||
|   void refresh(Field& U, GridParallelRNG& pRNG)  | ||||
|   { | ||||
|     assert(P.Grid() == U.Grid()); | ||||
|     std::cout << GridLogIntegrator << "Integrator refresh\n"; | ||||
|  | ||||
|     FieldImplementation::generate_momenta(P, sRNG, pRNG); | ||||
|     FieldImplementation::generate_momenta(P, pRNG); | ||||
|  | ||||
|     // Update the smeared fields, can be implemented as observer | ||||
|     // necessary to keep the fields updated even after a reject | ||||
| @@ -268,14 +243,12 @@ public: | ||||
|         // get gauge field from the SmearingPolicy and | ||||
|         // based on the boolean is_smeared in actionID | ||||
|         Field& Us = Smearer.get_U(as[level].actions.at(actionID)->is_smeared); | ||||
|         as[level].actions.at(actionID)->refresh(Us, sRNG, pRNG); | ||||
|         as[level].actions.at(actionID)->refresh(Us, pRNG); | ||||
|       } | ||||
|  | ||||
|       // Refresh the higher representation actions | ||||
|       as[level].apply(refresh_hireps, Representations, sRNG, pRNG); | ||||
|       as[level].apply(refresh_hireps, Representations, pRNG); | ||||
|     } | ||||
|  | ||||
|     MomFilter->applyFilter(P); | ||||
|   } | ||||
|  | ||||
|   // to be used by the actionlevel class to iterate | ||||
|   | ||||
| @@ -1,94 +0,0 @@ | ||||
| /************************************************************************************* | ||||
|  | ||||
| Grid physics library, www.github.com/paboyle/Grid | ||||
|  | ||||
| Source file: ./lib/qcd/hmc/integrators/MomentumFilter.h | ||||
|  | ||||
| Copyright (C) 2015 | ||||
|  | ||||
| Author: Christopher Kelly <ckelly@bnl.gov> | ||||
| Author: Peter Boyle <paboyle@ph.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 | ||||
| the Free Software Foundation; either version 2 of the License, or | ||||
| (at your option) any later version. | ||||
|  | ||||
| This program is distributed in the hope that it will be useful, | ||||
| but WITHOUT ANY WARRANTY; without even the implied warranty of | ||||
| MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE.  See the | ||||
| GNU General Public License for more details. | ||||
|  | ||||
| You should have received a copy of the GNU General Public License along | ||||
| with this program; if not, write to the Free Software Foundation, Inc., | ||||
| 51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. | ||||
|  | ||||
| See the full license in the file "LICENSE" in the top level distribution | ||||
| directory | ||||
| *************************************************************************************/ | ||||
| /*  END LEGAL */ | ||||
| //-------------------------------------------------------------------- | ||||
| #ifndef MOMENTUM_FILTER | ||||
| #define MOMENTUM_FILTER | ||||
|  | ||||
| NAMESPACE_BEGIN(Grid); | ||||
|  | ||||
| //These filter objects allow the user to manipulate the conjugate momentum as part of the update / refresh | ||||
|  | ||||
| template<typename MomentaField> | ||||
| struct MomentumFilterBase{ | ||||
|   virtual void applyFilter(MomentaField &P) const; | ||||
| }; | ||||
|  | ||||
| //Do nothing | ||||
| template<typename MomentaField> | ||||
| struct MomentumFilterNone: public MomentumFilterBase<MomentaField>{ | ||||
|   void applyFilter(MomentaField &P) const override{} | ||||
| }; | ||||
|  | ||||
| //Multiply each site/direction by a Lorentz vector complex number field | ||||
| //Can be used to implement a mask, zeroing out sites | ||||
| template<typename MomentaField> | ||||
| struct MomentumFilterApplyPhase: public MomentumFilterBase<MomentaField>{ | ||||
|   typedef typename MomentaField::vector_type vector_type; //SIMD-vectorized complex type | ||||
|   typedef typename MomentaField::scalar_type scalar_type; //scalar complex type | ||||
|   typedef iVector<iScalar<iScalar<vector_type> >, Nd > LorentzScalarType; //complex phase for each site/direction | ||||
|   typedef Lattice<LorentzScalarType> LatticeLorentzScalarType; | ||||
|    | ||||
|   LatticeLorentzScalarType phase; | ||||
|   | ||||
|   MomentumFilterApplyPhase(const LatticeLorentzScalarType _phase): phase(_phase){} | ||||
|  | ||||
|   //Default to uniform field of (1,0) | ||||
|   MomentumFilterApplyPhase(GridBase* _grid): phase(_grid){ | ||||
|     LorentzScalarType one; | ||||
|     for(int mu=0;mu<Nd;mu++) | ||||
|       one(mu)()() = scalar_type(1.); | ||||
|      | ||||
|     phase = one; | ||||
|   } | ||||
|  | ||||
|   void applyFilter(MomentaField &P) const override{ | ||||
|     conformable(P,phase); | ||||
|     autoView( P_v , P, AcceleratorWrite); | ||||
|     autoView( phase_v , phase, AcceleratorRead); | ||||
|  | ||||
|     accelerator_for(ss,P_v.size(),MomentaField::vector_type::Nsimd(),{ | ||||
|     	auto site_mom = P_v(ss); | ||||
|     	auto site_phase = phase_v(ss); | ||||
| 	for(int mu=0;mu<Nd;mu++) | ||||
| 	  site_mom(mu) = site_mom(mu) * site_phase(mu); | ||||
|     	coalescedWrite(P_v[ss], site_mom); | ||||
|       }); | ||||
|      | ||||
|   } | ||||
|  | ||||
|  | ||||
| }; | ||||
|  | ||||
|  | ||||
|  | ||||
|  | ||||
| NAMESPACE_END(Grid); | ||||
|  | ||||
| #endif | ||||
										
											
												File diff suppressed because it is too large
												Load Diff
											
										
									
								
							| @@ -93,13 +93,13 @@ public: | ||||
|   GeneralisedMomenta(GridBase* grid, Metric<MomentaField>& M): M(M), Mom(grid), AuxMom(grid), AuxField(grid){} | ||||
|  | ||||
|   // Correct | ||||
|   void MomentaDistribution(GridSerialRNG & sRNG, GridParallelRNG& pRNG){ | ||||
|   void MomentaDistribution(GridParallelRNG& pRNG){ | ||||
|     // Generate a distribution for | ||||
|     // P^dag G P | ||||
|     // where G = M^-1 | ||||
|  | ||||
|     // Generate gaussian momenta | ||||
|     Implementation::generate_momenta(Mom, sRNG, pRNG); | ||||
|     Implementation::generate_momenta(Mom, pRNG); | ||||
|     // Modify the distribution with the metric | ||||
|     M.MSquareRoot(Mom); | ||||
|  | ||||
| @@ -107,8 +107,8 @@ public: | ||||
|       // Auxiliary momenta | ||||
|       // do nothing if trivial, so hide in the metric | ||||
|       MomentaField AuxMomTemp(Mom.Grid()); | ||||
|       Implementation::generate_momenta(AuxMom, sRNG, pRNG); | ||||
|       Implementation::generate_momenta(AuxField, sRNG, pRNG); | ||||
|       Implementation::generate_momenta(AuxMom, pRNG); | ||||
|       Implementation::generate_momenta(AuxField, pRNG); | ||||
|       // Modify the distribution with the metric | ||||
|       // Aux^dag M Aux | ||||
|       M.MInvSquareRoot(AuxMom);  // AuxMom = M^{-1/2} AuxMomTemp | ||||
|   | ||||
| @@ -67,7 +67,6 @@ public: | ||||
|   accelerator_inline GpuComplex(const GpuComplex &zz) { z = zz.z;}; | ||||
|   accelerator_inline Real real(void) const { return z.x; }; | ||||
|   accelerator_inline Real imag(void) const { return z.y; }; | ||||
|   accelerator_inline GpuComplex &operator=(const Zero &zz) { z.x = 0; z.y=0; return *this; }; | ||||
|   accelerator_inline GpuComplex &operator*=(const GpuComplex &r) { | ||||
|     *this = (*this) * r; | ||||
|     return *this; | ||||
|   | ||||
| @@ -208,8 +208,8 @@ struct RealPart<complex<T> > { | ||||
| ////////////////////////////////////// | ||||
| // type alias used to simplify the syntax of std::enable_if | ||||
| template <typename T> using Invoke = typename T::type; | ||||
| template <typename Condition, typename ReturnType = void> using EnableIf    = Invoke<std::enable_if<Condition::value, ReturnType> >; | ||||
| template <typename Condition, typename ReturnType = void> using NotEnableIf = Invoke<std::enable_if<!Condition::value, ReturnType> >; | ||||
| template <typename Condition, typename ReturnType> using EnableIf    = Invoke<std::enable_if<Condition::value, ReturnType> >; | ||||
| template <typename Condition, typename ReturnType> using NotEnableIf = Invoke<std::enable_if<!Condition::value, ReturnType> >; | ||||
|  | ||||
| //////////////////////////////////////////////////////// | ||||
| // Check for complexity with type traits | ||||
|   | ||||
| @@ -221,7 +221,7 @@ public: | ||||
|   typedef typename cobj::vector_type vector_type; | ||||
|   typedef typename cobj::scalar_type scalar_type; | ||||
|   typedef typename cobj::scalar_object scalar_object; | ||||
|   typedef const CartesianStencilView<vobj,cobj,Parameters> View_type; | ||||
|   typedef CartesianStencilView<vobj,cobj,Parameters> View_type; | ||||
|   typedef typename View_type::StencilVector StencilVector; | ||||
|   /////////////////////////////////////////// | ||||
|   // Helper structs | ||||
|   | ||||
| @@ -65,8 +65,8 @@ void coalescedWriteNonTemporal(vobj & __restrict__ vec,const vobj & __restrict__ | ||||
| #else | ||||
|  | ||||
|  | ||||
| #ifndef GRID_SYCL | ||||
| // Use the scalar as our own complex on GPU ... thrust::complex or std::complex | ||||
| #if 0 | ||||
| // Use the scalar as our own complex on GPU | ||||
| template<class vsimd,IfSimd<vsimd> = 0> accelerator_inline | ||||
| typename vsimd::scalar_type | ||||
| coalescedRead(const vsimd & __restrict__ vec,int lane=acceleratorSIMTlane(vsimd::Nsimd())) | ||||
| @@ -96,8 +96,6 @@ void coalescedWrite(vsimd & __restrict__ vec, | ||||
|   p[lane]=extracted; | ||||
| } | ||||
| #else | ||||
| // For SyCL have option to use GpuComplex from inside the vector type in SIMT loops | ||||
| // Faster for some reason | ||||
| template<class vsimd,IfSimd<vsimd> = 0> accelerator_inline | ||||
| typename vsimd::vector_type::datum | ||||
| coalescedRead(const vsimd & __restrict__ vec,int lane=acceleratorSIMTlane(vsimd::Nsimd())) | ||||
|   | ||||
| @@ -28,7 +28,7 @@ Author: neo <cossu@post.kek.jp> | ||||
| #ifndef GRID_MATH_EXP_H | ||||
| #define GRID_MATH_EXP_H | ||||
|  | ||||
| #define DEFAULT_MAT_EXP 20 | ||||
| #define DEFAULT_MAT_EXP 12 | ||||
|  | ||||
| NAMESPACE_BEGIN(Grid); | ||||
|  | ||||
|   | ||||
| @@ -53,6 +53,7 @@ void acceleratorInit(void) | ||||
|     prop = gpu_props[i]; | ||||
|     totalDeviceMem = prop.totalGlobalMem; | ||||
|     if ( world_rank == 0) { | ||||
| #ifndef GRID_DEFAULT_GPU | ||||
|       if ( i==rank ) { | ||||
| 	printf("AcceleratorCudaInit[%d]: ========================\n",rank); | ||||
| 	printf("AcceleratorCudaInit[%d]: Device Number    : %d\n", rank,i); | ||||
| @@ -66,8 +67,8 @@ void acceleratorInit(void) | ||||
| 	GPU_PROP(warpSize); | ||||
| 	GPU_PROP(pciBusID); | ||||
| 	GPU_PROP(pciDeviceID); | ||||
|  	printf("AcceleratorCudaInit[%d]: maxGridSize (%d,%d,%d)\n",rank,prop.maxGridSize[0],prop.maxGridSize[1],prop.maxGridSize[2]); | ||||
|       } | ||||
| #endif | ||||
|       //      GPU_PROP(unifiedAddressing); | ||||
|       //      GPU_PROP(l2CacheSize); | ||||
|       //      GPU_PROP(singleToDoublePrecisionPerfRatio); | ||||
|   | ||||
| @@ -104,7 +104,7 @@ extern int acceleratorAbortOnGpuError; | ||||
|  | ||||
| accelerator_inline int acceleratorSIMTlane(int Nsimd) { | ||||
| #ifdef GRID_SIMT | ||||
|   return threadIdx.x;  | ||||
|   return threadIdx.z;  | ||||
| #else | ||||
|   return 0; | ||||
| #endif | ||||
| @@ -112,76 +112,36 @@ accelerator_inline int acceleratorSIMTlane(int Nsimd) { | ||||
|  | ||||
| #define accelerator_for2dNB( iter1, num1, iter2, num2, nsimd, ... )	\ | ||||
|   {									\ | ||||
|     int nt=acceleratorThreads();					\ | ||||
|     typedef uint64_t Iterator;						\ | ||||
|     auto lambda = [=] accelerator					\ | ||||
|       (Iterator iter1,Iterator iter2,Iterator lane) mutable {		\ | ||||
|       __VA_ARGS__;							\ | ||||
|     };									\ | ||||
|     dim3 cu_threads(nsimd,acceleratorThreads(),1);			\ | ||||
|     int nt=acceleratorThreads();					\ | ||||
|     dim3 cu_threads(acceleratorThreads(),1,nsimd);			\ | ||||
|     dim3 cu_blocks ((num1+nt-1)/nt,num2,1);				\ | ||||
|     LambdaApply<<<cu_blocks,cu_threads>>>(num1,num2,nsimd,lambda);	\ | ||||
|   } | ||||
|  | ||||
| #define accelerator_for6dNB(iter1, num1,				\ | ||||
|                             iter2, num2,				\ | ||||
|                             iter3, num3,				\ | ||||
|                             iter4, num4,				\ | ||||
|                             iter5, num5,				\ | ||||
| 			    iter6, num6, ... )				\ | ||||
|   {									\ | ||||
|     typedef uint64_t Iterator;						\ | ||||
|     auto lambda = [=] accelerator					\ | ||||
|       (Iterator iter1,Iterator iter2,					\ | ||||
|        Iterator iter3,Iterator iter4,					\ | ||||
|        Iterator iter5,Iterator iter6) mutable {				\ | ||||
|       __VA_ARGS__;							\ | ||||
|     };									\ | ||||
|     dim3 cu_blocks (num1,num2,num3);					\ | ||||
|     dim3 cu_threads(num4,num5,num6);					\ | ||||
|     Lambda6Apply<<<cu_blocks,cu_threads>>>(num1,num2,num3,num4,num5,num6,lambda); \ | ||||
|   } | ||||
|  | ||||
| template<typename lambda>  __global__ | ||||
| void LambdaApply(uint64_t num1, uint64_t num2, uint64_t num3, lambda Lambda) | ||||
| { | ||||
|   // Weird permute is to make lane coalesce for large blocks | ||||
|   uint64_t x = threadIdx.y + blockDim.y*blockIdx.x; | ||||
|   uint64_t y = threadIdx.z + blockDim.z*blockIdx.y; | ||||
|   uint64_t z = threadIdx.x; | ||||
|   uint64_t x = threadIdx.x + blockDim.x*blockIdx.x; | ||||
|   uint64_t y = threadIdx.y + blockDim.y*blockIdx.y; | ||||
|   uint64_t z = threadIdx.z; | ||||
|   if ( (x < num1) && (y<num2) && (z<num3) ) { | ||||
|     Lambda(x,y,z); | ||||
|   } | ||||
| } | ||||
|  | ||||
| template<typename lambda>  __global__ | ||||
| void Lambda6Apply(uint64_t num1, uint64_t num2, uint64_t num3, | ||||
| 		  uint64_t num4, uint64_t num5, uint64_t num6, | ||||
| 		  lambda Lambda) | ||||
| { | ||||
|   uint64_t iter1 = blockIdx.x; | ||||
|   uint64_t iter2 = blockIdx.y; | ||||
|   uint64_t iter3 = blockIdx.z; | ||||
|   uint64_t iter4 = threadIdx.x; | ||||
|   uint64_t iter5 = threadIdx.y; | ||||
|   uint64_t iter6 = threadIdx.z; | ||||
|  | ||||
|   if ( (iter1 < num1) && (iter2<num2) && (iter3<num3) | ||||
|     && (iter4 < num4) && (iter5<num5) && (iter6<num6) ) | ||||
|   { | ||||
|     Lambda(iter1,iter2,iter3,iter4,iter5,iter6); | ||||
|   } | ||||
| } | ||||
|  | ||||
| #define accelerator_barrier(dummy)					\ | ||||
|   {									\ | ||||
|     cudaDeviceSynchronize();						\ | ||||
|     cudaError err = cudaGetLastError();					\ | ||||
|     if ( cudaSuccess != err ) {						\ | ||||
|       printf("accelerator_barrier(): Cuda error %s \n",			\ | ||||
| 	     cudaGetErrorString( err ));				\ | ||||
|       printf("File %s Line %d\n",__FILE__,__LINE__);			\ | ||||
|       fflush(stdout);							\ | ||||
|       printf("Cuda error %s \n", cudaGetErrorString( err ));		\ | ||||
|       puts(__FILE__);							\ | ||||
|       printf("Line %d\n",__LINE__);					\ | ||||
|       if (acceleratorAbortOnGpuError) assert(err==cudaSuccess);		\ | ||||
|     }									\ | ||||
|   } | ||||
| @@ -457,7 +417,7 @@ accelerator_inline void acceleratorSynchronise(void) | ||||
|   __syncwarp(); | ||||
| #endif | ||||
| #ifdef GRID_SYCL | ||||
|   cl::sycl::detail::workGroupBarrier(); | ||||
|   // No barrier call on SYCL??  // Option get __spir:: stuff to do warp barrier | ||||
| #endif | ||||
| #ifdef GRID_HIP | ||||
|   __syncthreads(); | ||||
|   | ||||
| @@ -1,16 +1,5 @@ | ||||
| #pragma once  | ||||
|  | ||||
| #if defined(__NVCC__) | ||||
|  | ||||
| #if (__CUDACC_VER_MAJOR__ == 11) && (__CUDACC_VER_MINOR__ == 0) | ||||
| #error "NVCC version 11.0 breaks on Ampere, see Github issue 346" | ||||
| #endif | ||||
| #if (__CUDACC_VER_MAJOR__ == 11) && (__CUDACC_VER_MINOR__ == 1) | ||||
| #error "NVCC version 11.1 breaks on Ampere, see Github issue 346" | ||||
| #endif | ||||
|  | ||||
| #endif | ||||
|  | ||||
| #if defined(__clang__) | ||||
|  | ||||
|   #if __clang_major__ < 3 | ||||
|   | ||||
| @@ -140,7 +140,7 @@ void GridCmdOptionCSL(std::string str,std::vector<std::string> & vec) | ||||
| } | ||||
|  | ||||
| template<class VectorInt> | ||||
| void GridCmdOptionIntVector(const std::string &str,VectorInt & vec) | ||||
| void GridCmdOptionIntVector(std::string &str,VectorInt & vec) | ||||
| { | ||||
|   vec.resize(0); | ||||
|   std::stringstream ss(str); | ||||
| @@ -153,9 +153,6 @@ void GridCmdOptionIntVector(const std::string &str,VectorInt & vec) | ||||
|   return; | ||||
| } | ||||
|  | ||||
| template void GridCmdOptionIntVector(const std::string &str,std::vector<int> & vec); | ||||
| template void GridCmdOptionIntVector(const std::string &str,Coordinate & vec); | ||||
|  | ||||
| void GridCmdOptionInt(std::string &str,int & val) | ||||
| { | ||||
|   std::stringstream ss(str); | ||||
|   | ||||
| @@ -55,7 +55,7 @@ template<class VectorInt> | ||||
| std::string GridCmdVectorIntToString(const VectorInt & vec); | ||||
| void GridCmdOptionCSL(std::string str,std::vector<std::string> & vec); | ||||
| template<class VectorInt> | ||||
| void GridCmdOptionIntVector(const std::string &str,VectorInt & vec); | ||||
| void GridCmdOptionIntVector(std::string &str,VectorInt & vec); | ||||
| void GridCmdOptionInt(std::string &str,int & val); | ||||
|  | ||||
|  | ||||
|   | ||||
| @@ -56,12 +56,12 @@ int main(int argc, char **argv) { | ||||
|   MD.trajL   = 1.0; | ||||
|  | ||||
|   HMCparameters HMCparams; | ||||
|   HMCparams.StartTrajectory  = 0; | ||||
|   HMCparams.StartTrajectory  = 30; | ||||
|   HMCparams.Trajectories     = 200; | ||||
|   HMCparams.NoMetropolisUntil=  0; | ||||
|   // "[HotStart, ColdStart, TepidStart, CheckpointStart]\n"; | ||||
|   HMCparams.StartingType     =std::string("ColdStart"); | ||||
|   //  HMCparams.StartingType     =std::string("CheckpointStart"); | ||||
|   //  HMCparams.StartingType     =std::string("ColdStart"); | ||||
|   HMCparams.StartingType     =std::string("CheckpointStart"); | ||||
|   HMCparams.MD = MD; | ||||
|   HMCWrapper TheHMC(HMCparams); | ||||
|  | ||||
|   | ||||
| @@ -149,6 +149,7 @@ If you want to build all the tests at once just use `make tests`. | ||||
| - `--enable-numa`: enable NUMA first touch optimisation | ||||
| - `--enable-simd=<code>`: setup Grid for the SIMD target `<code>` (default: `GEN`). A list of possible SIMD targets is detailed in a section below. | ||||
| - `--enable-gen-simd-width=<size>`: select the size (in bytes) of the generic SIMD vector type (default: 32 bytes). | ||||
| - `--enable-precision={single|double}`: set the default precision (default: `double`). **Deprecated option** | ||||
| - `--enable-comms=<comm>`: Use `<comm>` for message passing (default: `none`). A list of possible SIMD targets is detailed in a section below. | ||||
| - `--enable-rng={sitmo|ranlux48|mt19937}`: choose the RNG (default: `sitmo `). | ||||
| - `--disable-timers`: disable system dependent high-resolution timers. | ||||
|   | ||||
							
								
								
									
										75
									
								
								TODO
									
									
									
									
									
								
							
							
						
						
									
										75
									
								
								TODO
									
									
									
									
									
								
							| @@ -1,6 +1,3 @@ | ||||
| -- comms threads issue?? | ||||
| -- Part done: Staggered kernel performance on GPU | ||||
|  | ||||
| ========================================================= | ||||
| General | ||||
| ========================================================= | ||||
| @@ -8,18 +5,28 @@ General | ||||
| - Make representations code take Gimpl | ||||
| - Simplify the HMCand remove modules | ||||
| - Lattice_arith - are the mult, mac etc.. still needed after ET engine? | ||||
| - Lattice_rng - faster local only loop in init | ||||
| - Audit: accelerate A2Autils -- off critical path for HMC | ||||
| - Lattice_rng | ||||
| - Lattice_transfer.h | ||||
| - accelerate A2Autils -- off critical path for HMC | ||||
|  | ||||
| ========================================================= | ||||
| GPU  work list | ||||
| GPU branch code item work list | ||||
| ========================================================= | ||||
|  | ||||
| * sum_cpu promote to double during summation for increased precision. | ||||
| * sum_cpu promote to double during summation for increased precisoin. | ||||
| * Introduce sumD & ReduceD  | ||||
| * GPU sum is probably better currently. | ||||
|  | ||||
| * Accelerate the cshift & benchmark | ||||
|  | ||||
| * 0) Single GPU | ||||
| - 128 bit integer table load in GPU code. | ||||
|   - ImprovedStaggered accelerate & measure perf | ||||
|   - Gianluca's changes to Cayley into gpu-port | ||||
|   - Mobius kernel fusion.                     -- Gianluca? | ||||
|   - Lebesque order reintroduction. StencilView should have pointer to it | ||||
|   - Lebesgue reorder in all kernels | ||||
|  | ||||
| * 3) Comms/NVlink | ||||
| - OpenMP tasks to run comms threads. Experiment with it  | ||||
| - Remove explicit openMP in staggered.  | ||||
| @@ -28,6 +35,14 @@ GPU  work list | ||||
| - Stencil gather ?? | ||||
| - SIMD dirs in stencil | ||||
|  | ||||
| * 4) ET enhancements | ||||
| - eval -> scalar ops in ET engine | ||||
| - coalescedRead, coalescedWrite in expressions. | ||||
|  | ||||
| * 5) Misc | ||||
| - Conserved current clean up. | ||||
| - multLinkProp eliminate | ||||
|  | ||||
| 8) Merge develop and test HMC | ||||
|  | ||||
| 9) Gamma tables on GPU; check this. Appear to work, but no idea why. Are these done on CPU? | ||||
| @@ -37,7 +52,7 @@ GPU  work list | ||||
| -     Audit NAMESPACE CHANGES | ||||
| -     Audit changes | ||||
|  | ||||
| --------- | ||||
| ----- | ||||
| Gianluca's changes | ||||
| - Performance impact of construct in aligned allocator??? | ||||
| --------- | ||||
| @@ -47,33 +62,6 @@ Gianluca's changes | ||||
| ----------------------------- | ||||
| DONE: | ||||
| ----------------------------- | ||||
| ===== | ||||
| -- Done: Remez X^-1/2 X^-1/2 X = 1 test. | ||||
|          Feed in MdagM^2 as a test and take its sqrt. | ||||
|          Automated test that MdagM invsqrt(MdagM)invsqrt(MdagM) = 1 in HMC for bounds satisfaction. | ||||
|  | ||||
| -- Done: Sycl Kernels into develop. Compare to existing unroll and just use. | ||||
| -- Done: sRNG into refresh functions | ||||
| -- Done: Tuned decomposition on CUDA into develop | ||||
| -- Done: Sycl friend accessor. Const view attempt via typedef?? | ||||
|  | ||||
|  | ||||
| * Done 5) Misc | ||||
| - Conserved current clean up. | ||||
| - multLinkProp eliminate | ||||
|  | ||||
| * Done 0) Single GPU | ||||
| - 128 bit integer table load in GPU code. | ||||
|   - ImprovedStaggered accelerate & measure perf | ||||
|   - Gianluca's changes to Cayley into gpu-port | ||||
|   - Mobius kernel fusion.                     -- Gianluca? | ||||
|   - Lebesque order reintroduction. StencilView should have pointer to it | ||||
|   - Lebesgue reorder in all kernels | ||||
|  | ||||
| * 4) ET enhancements | ||||
| - Done eval -> scalar ops in ET engine | ||||
| - Done coalescedRead, coalescedWrite in expressions. | ||||
|  | ||||
| ============================================================================================= | ||||
| AUDIT ContractWWVV with respect to develop    -- DONE | ||||
| - GPU accelerate EOFA                                                  -- DONE | ||||
| @@ -137,6 +125,23 @@ AUDIT ContractWWVV with respect to develop    -- DONE | ||||
| - -      (4) omp parallel for collapse(n) | ||||
| - - Only (1) has a natural mirror in accelerator_loop | ||||
| - - Nested loop macros get cumbersome made a generic interface for N deep | ||||
| - - Don't like thread_region and thread_loop_in_region | ||||
| - - Could replace with  | ||||
|  | ||||
|     thread_nested(1,  | ||||
|       for { | ||||
|  | ||||
|       } | ||||
|     ); | ||||
|     thread_nested(2, | ||||
|       for (){ | ||||
|         for (){ | ||||
|  | ||||
| 	} | ||||
|       } | ||||
|     ); | ||||
|  | ||||
|     and same "in_region". | ||||
|  | ||||
|  | ||||
| ----------------------------- | ||||
|   | ||||
| @@ -53,7 +53,7 @@ int main (int argc, char ** argv) | ||||
|   int threads = GridThread::GetThreads(); | ||||
|  | ||||
|   Coordinate latt4 = GridDefaultLatt(); | ||||
|   int Ls=16; | ||||
|   int Ls=8; | ||||
|   for(int i=0;i<argc;i++) | ||||
|     if(std::string(argv[i]) == "-Ls"){ | ||||
|       std::stringstream ss(argv[i+1]); ss >> Ls; | ||||
|   | ||||
							
								
								
									
										25
									
								
								configure.ac
									
									
									
									
									
								
							
							
						
						
									
										25
									
								
								configure.ac
									
									
									
									
									
								
							| @@ -7,12 +7,7 @@ AM_INIT_AUTOMAKE([subdir-objects 1.13]) | ||||
| AM_EXTRA_RECURSIVE_TARGETS([tests bench]) | ||||
| AC_CONFIG_MACRO_DIR([m4]) | ||||
| AC_CONFIG_SRCDIR([Grid/Grid.h]) | ||||
| AC_CONFIG_HEADERS([Grid/Config.h],[[$SED_INPLACE -e 's|PACKAGE_|GRID_|' -e 's|[[:space:]]PACKAGE[[:space:]]| GRID_PACKAGE |' -e 's|[[:space:]]VERSION[[:space:]]| GRID_PACKAGE_VERSION |' Grid/Config.h]], | ||||
|     [if test x"$host_os" == x"${host_os#darwin}" ; then] | ||||
|         [SED_INPLACE="sed -i"] | ||||
|     [else] | ||||
|         [SED_INPLACE="sed -i .bak"] | ||||
|     [fi]) | ||||
| AC_CONFIG_HEADERS([Grid/Config.h],[sed -i 's|PACKAGE_|GRID_|' Grid/Config.h]) | ||||
| m4_ifdef([AM_SILENT_RULES], [AM_SILENT_RULES([yes])]) | ||||
|  | ||||
| ################ Get git info | ||||
| @@ -130,7 +125,7 @@ esac | ||||
|  | ||||
| ############### fermions | ||||
| AC_ARG_ENABLE([fermion-reps], | ||||
|      [AC_HELP_STRING([--enable-fermion-reps=yes|no], [enable extra fermion representation support])], | ||||
|      [AC_HELP_STRING([--fermion-reps=yes|no], [enable extra fermion representation support])], | ||||
|      [ac_FERMION_REPS=${enable_fermion_reps}], [ac_FERMION_REPS=yes]) | ||||
|  | ||||
| AM_CONDITIONAL(BUILD_FERMION_REPS, [ test "${ac_FERMION_REPS}X" == "yesX" ]) | ||||
| @@ -140,23 +135,12 @@ AC_ARG_ENABLE([gparity], | ||||
|      [ac_GPARITY=${enable_gparity}], [ac_GPARITY=yes]) | ||||
|  | ||||
| AM_CONDITIONAL(BUILD_GPARITY, [ test "${ac_GPARITY}X" == "yesX" ]) | ||||
|  | ||||
| AC_ARG_ENABLE([zmobius], | ||||
|      [AC_HELP_STRING([--enable-zmobius=yes|no], [enable Zmobius support])], | ||||
|      [ac_ZMOBIUS=${enable_zmobius}], [ac_ZMOBIUS=yes]) | ||||
|  | ||||
| AM_CONDITIONAL(BUILD_ZMOBIUS, [ test "${ac_ZMOBIUS}X" == "yesX" ]) | ||||
|  | ||||
|  | ||||
| case ${ac_FERMION_REPS} in | ||||
|    yes) AC_DEFINE([ENABLE_FERMION_REPS],[1],[non QCD fermion reps]);; | ||||
| esac | ||||
| case ${ac_GPARITY} in | ||||
|    yes) AC_DEFINE([ENABLE_GPARITY],[1],[fermion actions with GPARITY BCs]);; | ||||
| esac | ||||
| case ${ac_ZMOBIUS} in | ||||
|    yes) AC_DEFINE([ENABLE_ZMOBIUS],[1],[Zmobius fermion actions]);; | ||||
| esac | ||||
| ############### Nc | ||||
| AC_ARG_ENABLE([Nc], | ||||
|     [AC_HELP_STRING([--enable-Nc=2|3|4], [enable number of colours])], | ||||
| @@ -444,7 +428,7 @@ case ${ax_cv_cxx_compiler_vendor} in | ||||
|         SIMD_FLAGS='-mavx2 -mfma -mf16c';; | ||||
|       AVX512) | ||||
|         AC_DEFINE([AVX512],[1],[AVX512 intrinsics]) | ||||
|         SIMD_FLAGS='-mavx512f -mavx512cd';; | ||||
|         SIMD_FLAGS='-mavx512f -mavx512pf -mavx512er -mavx512cd';; | ||||
|       SKL) | ||||
|         AC_DEFINE([AVX512],[1],[AVX512 intrinsics for SkyLake Xeon]) | ||||
|         SIMD_FLAGS='-march=skylake-avx512';; | ||||
| @@ -497,9 +481,6 @@ case ${ax_cv_cxx_compiler_vendor} in | ||||
|         AC_DEFINE([AVX2],[1],[AVX2 intrinsics]) | ||||
|         SIMD_FLAGS='-march=core-avx2 -xcore-avx2';; | ||||
|       AVX512) | ||||
|         AC_DEFINE([AVX512],[1],[AVX512 intrinsics]) | ||||
|         SIMD_FLAGS='-xcommon-avx512';; | ||||
|       SKL) | ||||
|         AC_DEFINE([AVX512],[1],[AVX512 intrinsics]) | ||||
|         SIMD_FLAGS='-xcore-avx512';; | ||||
|       KNC) | ||||
|   | ||||
| @@ -40,9 +40,9 @@ int main (int argc, char ** argv) | ||||
|  | ||||
|   int N=16; | ||||
|    | ||||
|   std::vector<int> latt_size  ({N,N,N,N}); | ||||
|   std::vector<int> simd_layout({vComplexD::Nsimd(),1,1,1}); | ||||
|   std::vector<int> mpi_layout ({1,1,1,1}); | ||||
|   std::vector<int> latt_size  ({N,4,4}); | ||||
|   std::vector<int> simd_layout({vComplexD::Nsimd(),1,1}); | ||||
|   std::vector<int> mpi_layout ({1,1,1}); | ||||
|  | ||||
|   int vol = 1; | ||||
|   int nd  = latt_size.size(); | ||||
| @@ -69,7 +69,7 @@ int main (int argc, char ** argv) | ||||
|     for(int t=0;t<latt_size[mu];t++){ | ||||
|       LatticeCoordinate(coor,mu); | ||||
|       sl=where(coor==Integer(t),rn,zz); | ||||
|       //      std::cout <<GridLogMessage<< " sl " << sl<<std::endl; | ||||
|       std::cout <<GridLogMessage<< " sl " << sl<<std::endl; | ||||
|       std::cout <<GridLogMessage<<" slice "<<t<<" " << norm2(sl)<<std::endl; | ||||
|       ns=ns+norm2(sl); | ||||
|     } | ||||
|   | ||||
| @@ -1,143 +0,0 @@ | ||||
|     /************************************************************************************* | ||||
|  | ||||
|     Grid physics library, www.github.com/paboyle/Grid  | ||||
|  | ||||
|     Source file: ./tests/Test_poisson_fft.cc | ||||
|  | ||||
|     Copyright (C) 2015 | ||||
|  | ||||
| Author: Azusa Yamaguchi <ayamaguc@staffmail.ed.ac.uk> | ||||
| Author: Peter Boyle <paboyle@ph.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 | ||||
|     the Free Software Foundation; either version 2 of the License, or | ||||
|     (at your option) any later version. | ||||
|  | ||||
|     This program is distributed in the hope that it will be useful, | ||||
|     but WITHOUT ANY WARRANTY; without even the implied warranty of | ||||
|     MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE.  See the | ||||
|     GNU General Public License for more details. | ||||
|  | ||||
|     You should have received a copy of the GNU General Public License along | ||||
|     with this program; if not, write to the Free Software Foundation, Inc., | ||||
|     51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. | ||||
|  | ||||
|     See the full license in the file "LICENSE" in the top level distribution directory | ||||
|     *************************************************************************************/ | ||||
|     /*  END LEGAL */ | ||||
| #include <Grid/Grid.h> | ||||
|  | ||||
| using namespace Grid; | ||||
|  ; | ||||
|  | ||||
| int main (int argc, char ** argv) | ||||
| { | ||||
|   Grid_init(&argc,&argv); | ||||
|  | ||||
|   int threads = GridThread::GetThreads(); | ||||
|   std::cout<<GridLogMessage << "Grid is setup to use "<<threads<<" threads"<<std::endl; | ||||
|  | ||||
|   int N=16; | ||||
|    | ||||
|   std::vector<int> latt_size  ({N,4,4}); | ||||
|   std::vector<int> simd_layout({vComplexD::Nsimd(),1,1}); | ||||
|   std::vector<int> mpi_layout ({1,1,1}); | ||||
|  | ||||
|   int vol = 1; | ||||
|   int nd  = latt_size.size(); | ||||
|   for(int d=0;d<nd;d++){ | ||||
|     vol = vol * latt_size[d]; | ||||
|   } | ||||
|  | ||||
|   GridCartesian         GRID(latt_size,simd_layout,mpi_layout); | ||||
|   GridParallelRNG RNG(&GRID); | ||||
|   RNG.SeedFixedIntegers(std::vector<int>({45,12,81,9}));   | ||||
|  | ||||
|   std::cout<<GridLogMessage<<"=============================================================="<<std::endl; | ||||
|   std::cout<<GridLogMessage<<"== LatticeComplex =="<<std::endl; | ||||
|   std::cout<<GridLogMessage<<"=============================================================="<<std::endl; | ||||
|   { | ||||
|     LatticeComplexD      zz(&GRID); | ||||
|     LatticeInteger     coor(&GRID); | ||||
|     LatticeComplexD  rn(&GRID); | ||||
|     LatticeComplexD  sl(&GRID); | ||||
|  | ||||
|     zz  = ComplexD(0.0,0.0); | ||||
|  | ||||
|     gaussian(RNG,rn); | ||||
|      | ||||
|     RealD nn=norm2(rn); | ||||
|     for(int mu=0;mu<nd;mu++){ | ||||
|       RealD ns=0.0; | ||||
|       for(int t=0;t<latt_size[mu];t++){ | ||||
| 	LatticeCoordinate(coor,mu); | ||||
| 	sl=where(coor==Integer(t),rn,zz); | ||||
| 	std::cout <<GridLogMessage<<" slice "<<t<<" " << norm2(sl)<<std::endl; | ||||
| 	ns=ns+norm2(sl); | ||||
|       } | ||||
|       std::cout <<GridLogMessage <<" sliceNorm" <<mu<<" "<< nn <<" "<<ns<<" err " << nn-ns<<std::endl; | ||||
|       assert(abs(nn-ns) < 1.0e-10); | ||||
|     } | ||||
|   } | ||||
|  | ||||
|  | ||||
|   std::cout<<GridLogMessage<<"=============================================================="<<std::endl; | ||||
|   std::cout<<GridLogMessage<<"== LatticeFermion =="<<std::endl; | ||||
|   std::cout<<GridLogMessage<<"=============================================================="<<std::endl; | ||||
|   { | ||||
|     LatticeFermionD      zz(&GRID); | ||||
|     LatticeInteger     coor(&GRID); | ||||
|     LatticeFermionD  rn(&GRID); | ||||
|     LatticeFermionD  sl(&GRID); | ||||
|  | ||||
|     zz  = ComplexD(0.0,0.0); | ||||
|  | ||||
|     gaussian(RNG,rn); | ||||
|      | ||||
|     RealD nn=norm2(rn); | ||||
|     for(int mu=0;mu<nd;mu++){ | ||||
|       RealD ns=0.0; | ||||
|       for(int t=0;t<latt_size[mu];t++){ | ||||
| 	LatticeCoordinate(coor,mu); | ||||
| 	sl=where(coor==Integer(t),rn,zz); | ||||
| 	std::cout <<GridLogMessage<<" slice "<<t<<" " << norm2(sl)<<std::endl; | ||||
| 	ns=ns+norm2(sl); | ||||
|       } | ||||
|       std::cout <<GridLogMessage <<" sliceNorm" <<mu<<" "<< nn <<" "<<ns<<" err " << nn-ns<<std::endl; | ||||
|       assert(abs(nn-ns) < 1.0e-10); | ||||
|     } | ||||
|   } | ||||
|  | ||||
|  | ||||
|  | ||||
|   std::cout<<GridLogMessage<<"=============================================================="<<std::endl; | ||||
|   std::cout<<GridLogMessage<<"== LatticePropagator =="<<std::endl; | ||||
|   std::cout<<GridLogMessage<<"=============================================================="<<std::endl; | ||||
|  | ||||
|   { | ||||
|     LatticePropagatorD      zz(&GRID); | ||||
|     LatticeInteger     coor(&GRID); | ||||
|     LatticePropagatorD  rn(&GRID); | ||||
|     LatticePropagatorD  sl(&GRID); | ||||
|  | ||||
|     zz  = ComplexD(0.0,0.0); | ||||
|  | ||||
|     gaussian(RNG,rn); | ||||
|      | ||||
|     RealD nn=norm2(rn); | ||||
|     for(int mu=0;mu<nd;mu++){ | ||||
|       RealD ns=0.0; | ||||
|       for(int t=0;t<latt_size[mu];t++){ | ||||
| 	LatticeCoordinate(coor,mu); | ||||
| 	sl=where(coor==Integer(t),rn,zz); | ||||
| 	std::cout <<GridLogMessage<<" slice "<<t<<" " << norm2(sl)<<std::endl; | ||||
| 	ns=ns+norm2(sl); | ||||
|       } | ||||
|       std::cout <<GridLogMessage <<" sliceNorm" <<mu<<" "<< nn <<" "<<ns<<" err " << nn-ns<<std::endl; | ||||
|       assert(abs(nn-ns) < 1.0e-10); | ||||
|     } | ||||
|   } | ||||
|  | ||||
|   Grid_finalize(); | ||||
| } | ||||
| @@ -33,14 +33,13 @@ using namespace Grid; | ||||
|  | ||||
|  | ||||
| template<class What>  | ||||
| void  TestConserved(What & Ddwf, | ||||
| void  TestConserved(What & Ddwf, What & Ddwfrev,  | ||||
| 		    LatticeGaugeField &Umu, | ||||
| 		    GridCartesian         * FGrid,	       GridRedBlackCartesian * FrbGrid, | ||||
| 		    GridCartesian         * UGrid,	       GridRedBlackCartesian * UrbGrid, | ||||
| 		    RealD mass, RealD M5, | ||||
| 		    GridParallelRNG *RNG4, | ||||
| 		    GridParallelRNG *RNG5, | ||||
|                     What *Ddwfrev=nullptr); | ||||
| 		    GridParallelRNG *RNG5); | ||||
|  | ||||
|   Gamma::Algebra Gmu [] = { | ||||
|     Gamma::Algebra::GammaX, | ||||
| @@ -103,11 +102,10 @@ int main (int argc, char ** argv) | ||||
|   GridRedBlackCartesian * FrbGridF = SpaceTimeGrid::makeFiveDimRedBlackGrid(Ls,UGridF); | ||||
|  | ||||
|  | ||||
|   std::vector<int> seeds4({1,2,3,4}); | ||||
|   std::vector<int> seeds5({5,6,7,8}); | ||||
|   GridParallelRNG          RNG5(FGrid);  RNG5.SeedFixedIntegers(seeds5); | ||||
|   GridParallelRNG          RNG4(UGrid); | ||||
|   std::vector<int> seeds4({1,2,3,4}); RNG4.SeedFixedIntegers(seeds4); | ||||
|   //const std::string seeds4{ "test-gauge-3000" }; RNG4.SeedUniqueString( seeds4 ); | ||||
|   GridParallelRNG          RNG4(UGrid);  RNG4.SeedFixedIntegers(seeds4); | ||||
|  | ||||
|   LatticeGaugeField Umu(UGrid); | ||||
|   if( argc > 1 && argv[1][0] != '-' ) | ||||
| @@ -118,7 +116,7 @@ int main (int argc, char ** argv) | ||||
|   } | ||||
|   else | ||||
|   { | ||||
|     std::cout<<GridLogMessage <<"Using hot configuration"<<std::endl; | ||||
|     std::cout<<GridLogMessage <<"Using cold configuration"<<std::endl; | ||||
|     //SU<Nc>::ColdConfiguration(Umu); | ||||
|     SU<Nc>::HotConfiguration(RNG4,Umu); | ||||
|   } | ||||
| @@ -129,7 +127,7 @@ int main (int argc, char ** argv) | ||||
|   std::cout<<GridLogMessage <<"DomainWallFermion test"<<std::endl; | ||||
|   std::cout<<GridLogMessage <<"======================"<<std::endl; | ||||
|   DomainWallFermionR Ddwf(Umu,*FGrid,*FrbGrid,*UGrid,*UrbGrid,mass,M5); | ||||
|   TestConserved<DomainWallFermionR>(Ddwf,Umu,FGrid,FrbGrid,UGrid,UrbGrid,mass,M5,&RNG4,&RNG5); | ||||
|   TestConserved<DomainWallFermionR>(Ddwf,Ddwf,Umu,FGrid,FrbGrid,UGrid,UrbGrid,mass,M5,&RNG4,&RNG5); | ||||
|  | ||||
|   RealD b=1.5;// Scale factor b+c=2, b-c=1 | ||||
|   RealD c=0.5; | ||||
| @@ -139,13 +137,13 @@ int main (int argc, char ** argv) | ||||
|   std::cout<<GridLogMessage <<"MobiusFermion test"<<std::endl; | ||||
|   std::cout<<GridLogMessage <<"======================"<<std::endl; | ||||
|   MobiusFermionR Dmob(Umu,*FGrid,*FrbGrid,*UGrid,*UrbGrid,mass,M5,b,c); | ||||
|   TestConserved<MobiusFermionR>(Dmob,Umu,FGrid,FrbGrid,UGrid,UrbGrid,mass,M5,&RNG4,&RNG5); | ||||
|   TestConserved<MobiusFermionR>(Dmob,Dmob,Umu,FGrid,FrbGrid,UGrid,UrbGrid,mass,M5,&RNG4,&RNG5); | ||||
|  | ||||
|   std::cout<<GridLogMessage <<"======================"<<std::endl; | ||||
|   std::cout<<GridLogMessage <<"ScaledShamirFermion test"<<std::endl; | ||||
|   std::cout<<GridLogMessage <<"======================"<<std::endl; | ||||
|   ScaledShamirFermionR Dsham(Umu,*FGrid,*FrbGrid,*UGrid,*UrbGrid,mass,M5,2.0); | ||||
|   TestConserved<ScaledShamirFermionR>(Dsham,Umu,FGrid,FrbGrid,UGrid,UrbGrid,mass,M5,&RNG4,&RNG5); | ||||
|   TestConserved<ScaledShamirFermionR>(Dsham,Dsham,Umu,FGrid,FrbGrid,UGrid,UrbGrid,mass,M5,&RNG4,&RNG5); | ||||
|  | ||||
|   std::cout<<GridLogMessage <<"======================"<<std::endl; | ||||
|   std::cout<<GridLogMessage <<"ZMobiusFermion test"<<std::endl; | ||||
| @@ -154,7 +152,8 @@ int main (int argc, char ** argv) | ||||
|   //  for(int s=0;s<Ls;s++) omegasrev[s]=omegas[Ls-1-s]; | ||||
|   ZMobiusFermionR ZDmob(Umu,*FGrid,*FrbGrid,*UGrid,*UrbGrid,mass,M5,omegas,b,c); | ||||
|   ZMobiusFermionR ZDmobrev(Umu,*FGrid,*FrbGrid,*UGrid,*UrbGrid,mass,M5,omegasrev,b,c); | ||||
|   TestConserved<ZMobiusFermionR>(ZDmob,Umu,FGrid,FrbGrid,UGrid,UrbGrid,mass,M5,&RNG4,&RNG5,&ZDmobrev); | ||||
|  | ||||
|   TestConserved<ZMobiusFermionR>(ZDmob,ZDmobrev,Umu,FGrid,FrbGrid,UGrid,UrbGrid,mass,M5,&RNG4,&RNG5); | ||||
|  | ||||
|   Grid_finalize(); | ||||
| } | ||||
| @@ -163,15 +162,20 @@ int main (int argc, char ** argv) | ||||
|  | ||||
| template<class Action>  | ||||
| void  TestConserved(Action & Ddwf,  | ||||
| 		    Action & Ddwfrev,  | ||||
| 		    LatticeGaugeField &Umu, | ||||
| 		    GridCartesian         * FGrid,	       GridRedBlackCartesian * FrbGrid, | ||||
| 		    GridCartesian         * UGrid,	       GridRedBlackCartesian * UrbGrid, | ||||
| 		    RealD mass, RealD M5, | ||||
| 		    GridParallelRNG *RNG4, | ||||
| 		    GridParallelRNG *RNG5, | ||||
|                     Action * Ddwfrev) | ||||
| 		    GridParallelRNG *RNG5) | ||||
| { | ||||
|   int Ls=Ddwf.Ls; | ||||
|  | ||||
|   LatticePropagator phys_src(UGrid);  | ||||
|  | ||||
|   std::vector<LatticeColourMatrix> U(4,UGrid); | ||||
|    | ||||
|   LatticePropagator seqsrc(FGrid);  | ||||
|   LatticePropagator prop5(FGrid);  | ||||
|   LatticePropagator prop5rev(FGrid);  | ||||
| @@ -190,9 +194,9 @@ void  TestConserved(Action & Ddwf, | ||||
|   phys_src=Zero(); | ||||
|   pokeSite(kronecker,phys_src,coor); | ||||
|    | ||||
|   MdagMLinearOperator<Action,LatticeFermion> HermOp(Ddwf); | ||||
|   MdagMLinearOperator<Action,LatticeFermion> HermOprev(Ddwfrev); | ||||
|   ConjugateGradient<LatticeFermion> CG(1.0e-16,100000); | ||||
|   SchurRedBlackDiagTwoSolve<LatticeFermion> schur(CG); | ||||
|   ZeroGuesser<LatticeFermion> zpg; | ||||
|   for(int s=0;s<Nd;s++){ | ||||
|     for(int c=0;c<Nc;c++){ | ||||
|       LatticeFermion src4  (UGrid);  | ||||
| @@ -202,20 +206,20 @@ void  TestConserved(Action & Ddwf, | ||||
|       Ddwf.ImportPhysicalFermionSource(src4,src5); | ||||
|  | ||||
|       LatticeFermion result5(FGrid); result5=Zero(); | ||||
|       schur(Ddwf,src5,result5,zpg); | ||||
|       std::cout<<GridLogMessage<<"spin "<<s<<" color "<<c<<" norm2(sourc5d) "<<norm2(src5) | ||||
|                <<" norm2(result5d) "<<norm2(result5)<<std::endl; | ||||
|  | ||||
|       // CGNE | ||||
|       LatticeFermion Mdagsrc5  (FGrid);  | ||||
|       Ddwf.Mdag(src5,Mdagsrc5); | ||||
|       CG(HermOp,Mdagsrc5,result5); | ||||
|       FermToProp<Action>(prop5,result5,s,c); | ||||
|  | ||||
|       LatticeFermion result4(UGrid); | ||||
|       Ddwf.ExportPhysicalFermionSolution(result5,result4); | ||||
|       FermToProp<Action>(prop4,result4,s,c); | ||||
|  | ||||
|       if( Ddwfrev ) { | ||||
|         Ddwfrev->ImportPhysicalFermionSource(src4,src5); | ||||
|         result5 = Zero(); | ||||
|         schur(*Ddwfrev,src5,result5,zpg); | ||||
|       } | ||||
|       Ddwfrev.ImportPhysicalFermionSource(src4,src5); | ||||
|       Ddwfrev.Mdag(src5,Mdagsrc5); | ||||
|       CG(HermOprev,Mdagsrc5,result5); | ||||
|       FermToProp<Action>(prop5rev,result5,s,c); | ||||
|     } | ||||
|   } | ||||
| @@ -247,7 +251,11 @@ void  TestConserved(Action & Ddwf, | ||||
|       PropToFerm<Action>(src5,seqsrc,s,c); | ||||
|  | ||||
|       LatticeFermion result5(FGrid); result5=Zero(); | ||||
|       schur(Ddwf,src5,result5,zpg); | ||||
|  | ||||
|       // CGNE | ||||
|       LatticeFermion Mdagsrc5  (FGrid);  | ||||
|       Ddwf.Mdag(src5,Mdagsrc5); | ||||
|       CG(HermOp,Mdagsrc5,result5); | ||||
|  | ||||
|       LatticeFermion result4(UGrid); | ||||
|       Ddwf.ExportPhysicalFermionSolution(result5,result4); | ||||
| @@ -268,10 +276,10 @@ void  TestConserved(Action & Ddwf, | ||||
|   Ddwf.ContractConservedCurrent(prop5rev,prop5,Vector_mu,phys_src,Current::Vector,Tdir); | ||||
|   Ddwf.ContractJ5q(prop5,PJ5q); | ||||
|    | ||||
|   PA       = trace(g5*Axial_mu);      // Pseudoscalar-Axial conserved current | ||||
|   SV       = trace(Vector_mu);        // Scalar-Vector conserved current | ||||
|   VV       = trace(gT*Vector_mu);     // (local) Vector-Vector conserved current | ||||
|   PP       = trace(adj(prop4)*prop4); // Pseudoscalar density | ||||
|   PA       = trace(g5*Axial_mu); | ||||
|   SV       = trace(Vector_mu); | ||||
|   VV       = trace(gT*Vector_mu); | ||||
|   PP       = trace(adj(prop4)*prop4); | ||||
|    | ||||
|   // Spatial sum | ||||
|   sliceSum(PA,sumPA,Tdir); | ||||
| @@ -280,17 +288,15 @@ void  TestConserved(Action & Ddwf, | ||||
|   sliceSum(PP,sumPP,Tdir); | ||||
|   sliceSum(PJ5q,sumPJ5q,Tdir); | ||||
|  | ||||
|   const int Nt{static_cast<int>(sumPA.size())}; | ||||
|   std::cout<<GridLogMessage<<"Vector Ward identity by timeslice (~ 0)"<<std::endl; | ||||
|   int Nt=sumPA.size(); | ||||
|   for(int t=0;t<Nt;t++){ | ||||
|     std::cout<<GridLogMessage <<" t "<<t<<" SV "<<real(TensorRemove(sumSV[t]))<<" VV "<<real(TensorRemove(sumVV[t]))<<std::endl; | ||||
|     std::cout <<" SV "<<real(TensorRemove(sumSV[t])); | ||||
|     std::cout <<" VV "<<real(TensorRemove(sumVV[t]))<<std::endl; | ||||
|   } | ||||
|   std::cout<<GridLogMessage<<"Axial Ward identity by timeslice (defect ~ 0)"<<std::endl; | ||||
|   for(int t=0;t<Nt;t++){ | ||||
|     const RealD DmuPAmu{real(TensorRemove(sumPA[t]-sumPA[(t-1+Nt)%Nt]))}; | ||||
|     std::cout<<GridLogMessage<<" t "<<t<<" DmuPAmu "<<DmuPAmu | ||||
|              <<" PP "<<real(TensorRemove(sumPP[t]))<<" PJ5q "<<real(TensorRemove(sumPJ5q[t])) | ||||
|              <<" Ward Identity defect " <<(DmuPAmu - 2.*real(TensorRemove(Ddwf.mass*sumPP[t] + sumPJ5q[t])))<<std::endl; | ||||
|     std::cout <<" PAc "<<real(TensorRemove(sumPA[t])); | ||||
|     std::cout <<" PJ5q "<<real(TensorRemove(sumPJ5q[t])); | ||||
|     std::cout <<" Ward Identity defect " <<real(TensorRemove(sumPA[t]-sumPA[(t-1+Nt)%Nt] - 2.0*(Ddwf.mass*sumPP[t] + sumPJ5q[t]) ))<<"\n"; | ||||
|   } | ||||
|    | ||||
|   /////////////////////////////// | ||||
|   | ||||
| @@ -86,9 +86,7 @@ int main (int argc, char** argv) | ||||
|   ConjugateGradient<LatticeFermion> CG(1.0e-12, 5000); | ||||
|   ExactOneFlavourRatioPseudoFermionAction<WilsonImplR> Meofa(Lop, Rop, CG, CG, CG, CG, CG, Params, true); | ||||
|  | ||||
|   GridSerialRNG  sRNG; sRNG.SeedFixedIntegers(seeds4); | ||||
|   Meofa.refresh(U, sRNG, RNG5 ); | ||||
|  | ||||
|   Meofa.refresh(U, RNG5); | ||||
|   RealD S = Meofa.S(U); // pdag M p | ||||
|  | ||||
|   // get the deriv of phidag M phi with respect to "U" | ||||
|   | ||||
| @@ -84,13 +84,6 @@ int main (int argc, char ** argv) | ||||
|   GparityDomainWallFermionR::ImplParams params; | ||||
|   params.twists = twists; | ||||
|  | ||||
|   /* | ||||
|   params.boundary_phases[0] = 1.0; | ||||
|   params.boundary_phases[1] = 1.0; | ||||
|   params.boundary_phases[2] = 1.0; | ||||
|   params.boundary_phases[3] =- 1.0; | ||||
|   */ | ||||
|    | ||||
|   GparityDomainWallFermionR Dw(U,*FGrid,*FrbGrid,*UGrid,*UrbGrid,mass,M5,params); | ||||
|  | ||||
|   Dw.M   (phi,Mphi); | ||||
| @@ -104,16 +97,6 @@ int main (int argc, char ** argv) | ||||
|   Dw.MDeriv(tmp , Mphi,  phi,DaggerNo );  UdSdU=tmp; | ||||
|   Dw.MDeriv(tmp , phi,  Mphi,DaggerYes ); UdSdU=(UdSdU+tmp); | ||||
|    | ||||
|   // ***************************************************************************************** | ||||
|   // *** There is a funny negative sign in all derivatives. This is - UdSdU.               *** | ||||
|   // ***                                                                                   *** | ||||
|   // *** Deriv in both Wilson gauge action and the TwoFlavour.h seems to miss a minus sign *** | ||||
|   // *** UdSdU is negated relative to what I think - call what is returned mUdSdU,         *** | ||||
|   // *** and insert minus sign                                                             *** | ||||
|   // ***************************************************************************************** | ||||
|  | ||||
|   UdSdU = - UdSdU ; // Follow sign convention of actions in Grid. Seems crazy. | ||||
|    | ||||
|   FermionField Ftmp      (FGrid); | ||||
|  | ||||
|   //////////////////////////////////// | ||||
| @@ -123,7 +106,7 @@ int main (int argc, char ** argv) | ||||
|   RealD Hmom = 0.0; | ||||
|   RealD Hmomprime = 0.0; | ||||
|   LatticeColourMatrix mommu(UGrid);  | ||||
|   LatticeColourMatrix mUdSdUmu(UGrid);  | ||||
|   LatticeColourMatrix forcemu(UGrid);  | ||||
|   LatticeGaugeField mom(UGrid);  | ||||
|   LatticeGaugeField Uprime(UGrid);  | ||||
|  | ||||
| @@ -131,20 +114,10 @@ int main (int argc, char ** argv) | ||||
|  | ||||
|     SU<Nc>::GaussianFundamentalLieAlgebraMatrix(RNG4, mommu); // Traceless antihermitian momentum; gaussian in lie alg | ||||
|  | ||||
|   // Momentum Hamiltonian is - trace(p^2)/HMC_MOM_DENOMINATOR | ||||
|   // | ||||
|   // Integrator.h:   RealD H = - FieldImplementation::FieldSquareNorm(P)/HMC_MOMENTUM_DENOMINATOR; // - trace (P*P)/denom                                                                                       //     GaugeImplTypes.h:        Hloc += trace(Pmu * Pmu); | ||||
|   //                          Sign comes from a sneaky multiply by "i" in GaussianFundemantalLie algebra | ||||
|   //                          P is i P^a_\mu T^a, not Pa Ta | ||||
|   //  | ||||
|   // Integrator.h: H =  Hmom + sum S(action) | ||||
|     Hmom -= real(sum(trace(mommu*mommu)))/ HMC_MOMENTUM_DENOMINATOR; | ||||
|     Hmom -= real(sum(trace(mommu*mommu))); | ||||
|  | ||||
|     PokeIndex<LorentzIndex>(mom,mommu,mu); | ||||
|  | ||||
|   // -- Drops factor of "i" in the U update: U' = e^{P dt} U   [ _not_ e^{iPdt}U ]. P is anti hermitian already | ||||
|   // -- Udot = p U | ||||
|  | ||||
|     // fourth order exponential approx | ||||
|     autoView( mom_v, mom, CpuRead); | ||||
|     autoView( U_v , U, CpuRead); | ||||
| @@ -161,8 +134,8 @@ int main (int argc, char ** argv) | ||||
| 	; | ||||
|     }); | ||||
|   } | ||||
|   std::cout << GridLogMessage <<"Initial mom hamiltonian is "<< Hmom <<std::endl; | ||||
|  | ||||
|   std::cout << GridLogMessage <<"Initial mom hamiltonian is "<< Hmom <<std::endl; | ||||
|   Dw.ImportGauge(Uprime); | ||||
|   Dw.M          (phi,MphiPrime); | ||||
|  | ||||
| @@ -172,60 +145,53 @@ int main (int argc, char ** argv) | ||||
|   // Use derivative to estimate dS | ||||
|   ////////////////////////////////////////////// | ||||
|  | ||||
|   // | ||||
|   // Ta has 1/2([ F - adj(F) ])_traceless and want the UdSdU _and_ UdagdSdUdag terms so 2x.  | ||||
|   // | ||||
|  | ||||
|   for(int mu=0;mu<Nd;mu++){ | ||||
|     std::cout << "" <<std::endl; | ||||
|     mommu   = PeekIndex<LorentzIndex>(mom,mu); | ||||
|     std::cout << GridLogMessage<< " Mommu  " << norm2(mommu)<<std::endl; | ||||
|     mommu   = mommu+adj(mommu); | ||||
|     std::cout << GridLogMessage<< " Mommu + Mommudag " << norm2(mommu)<<std::endl; | ||||
|     mommu   = PeekIndex<LorentzIndex>(UdSdU,mu); | ||||
|     std::cout << GridLogMessage<< " dsdumu  " << norm2(mommu)<<std::endl; | ||||
|     mommu   = mommu+adj(mommu); | ||||
|     std::cout << GridLogMessage<< " dsdumu + dag  " << norm2(mommu)<<std::endl; | ||||
|   } | ||||
|  | ||||
|   LatticeComplex dS(UGrid); dS = Zero(); | ||||
|   LatticeComplex dSmom(UGrid); dSmom = Zero(); | ||||
|   LatticeComplex dSmom2(UGrid); dSmom2 = Zero(); | ||||
|   for(int mu=0;mu<Nd;mu++){ | ||||
|     mommu   = PeekIndex<LorentzIndex>(UdSdU,mu); | ||||
|     mommu=Ta(mommu); // projectForce , GaugeImplTypes.h | ||||
|     mommu=Ta(mommu)*2.0; | ||||
|     PokeIndex<LorentzIndex>(UdSdU,mommu,mu); | ||||
|   } | ||||
|  | ||||
|   for(int mu=0;mu<Nd;mu++){ | ||||
|     mommu   = PeekIndex<LorentzIndex>(mom,mu); | ||||
|     std::cout << GridLogMessage<< " Mommu  " << norm2(mommu)<<std::endl; | ||||
|     mommu   = mommu+adj(mommu); | ||||
|     std::cout << GridLogMessage<< " Mommu + Mommudag " << norm2(mommu)<<std::endl; | ||||
|     mommu   = PeekIndex<LorentzIndex>(UdSdU,mu); | ||||
|     std::cout << GridLogMessage<< " dsdumu  " << norm2(mommu)<<std::endl; | ||||
|     mommu   = mommu+adj(mommu); | ||||
|     std::cout << GridLogMessage<< " dsdumu + dag  " << norm2(mommu)<<std::endl; | ||||
|   } | ||||
|  | ||||
|     mUdSdUmu= PeekIndex<LorentzIndex>(UdSdU,mu); | ||||
|   for(int mu=0;mu<Nd;mu++){ | ||||
|     forcemu = PeekIndex<LorentzIndex>(UdSdU,mu); | ||||
|     mommu   = PeekIndex<LorentzIndex>(mom,mu); | ||||
|  | ||||
|     // | ||||
|     // Derive HMC eom: | ||||
|     // | ||||
|     // Sdot =  - 2 trace( p p^dot ) / D - trace( p [ mUdSdU - h.c. ] ) = 0  | ||||
|     // | ||||
|     // | ||||
|     // Sdot = 0 = - 2 trace( p p^dot ) / D - 2 trace( p Ta( mUdSdU ) = 0 | ||||
|     // | ||||
|     // EOM:  | ||||
|     // | ||||
|     // pdot = - D Ta( mUdSdU ) -- source of sign is the "funny sign" above | ||||
|     // | ||||
|     // dSqcd_dt  = - 2.0*trace(mommu* Ta(mUdSdU) )*dt -- i.e. mUdSdU with adjoint term -> force has a 2x implicit | ||||
|     // | ||||
|     // dH_mom/dt = - 2 trace (p pdot)/Denom   | ||||
|     // | ||||
|     // dH_tot / dt = 0 <= pdot = - Denom * mUdSdU  | ||||
|     // | ||||
|     // dH_mom/dt = 2 trace (p mUdSdU )  | ||||
|     // | ||||
|     // True Momentum delta H has a dt^2 piece | ||||
|     // | ||||
|     // dSmom = [ trace mom*mom - trace ( (mom-Denom*f*dt)(mom-Denom*f*dt) ) ] / Denom | ||||
|     //       = 2*trace(mom*f) dt  - Denom*dt*dt * trace(f*f). | ||||
|     //       = dSmom + dSmom2 | ||||
|     // | ||||
|     // Update PF action density | ||||
|     dS = dS+trace(mommu*forcemu)*dt; | ||||
|  | ||||
|     dS     = dS - 2.0*trace(mommu*mUdSdUmu)*dt;   // U and Udagger derivs hence 2x. | ||||
|     dSmom  = dSmom  - trace(mommu*forcemu) * dt; | ||||
|     dSmom2 = dSmom2 - trace(forcemu*forcemu) *(0.25* dt*dt); | ||||
|  | ||||
|     dSmom  = dSmom  + 2.0*trace(mommu*mUdSdUmu) * dt;  // this 2.0 coms from derivative of p^2  | ||||
|     // Update mom action density | ||||
|     mommu = mommu + forcemu*(dt*0.5); | ||||
|  | ||||
|     dSmom2 = dSmom2 - trace(mUdSdUmu*mUdSdUmu) * dt*dt* HMC_MOMENTUM_DENOMINATOR; // Remnant | ||||
|  | ||||
|     // Update mom action density . Verbatim update_P in Integrator.h | ||||
|     mommu = mommu - mUdSdUmu * dt* HMC_MOMENTUM_DENOMINATOR;;  | ||||
|  | ||||
|     Hmomprime -= real(sum(trace(mommu*mommu))) / HMC_MOMENTUM_DENOMINATOR; | ||||
|     Hmomprime -= real(sum(trace(mommu*mommu))); | ||||
|  | ||||
|   } | ||||
|  | ||||
| @@ -233,25 +199,20 @@ int main (int argc, char ** argv) | ||||
|   ComplexD dSm       = sum(dSmom); | ||||
|   ComplexD dSm2      = sum(dSmom2); | ||||
|  | ||||
|   std::cout << GridLogMessage <<"dSm "<< dSm<<std::endl; | ||||
|   std::cout << GridLogMessage <<"dSm2 "<< dSm2<<std::endl; | ||||
|  | ||||
|   std::cout << GridLogMessage <<"Initial mom hamiltonian is "<< Hmom <<std::endl; | ||||
|   std::cout << GridLogMessage <<"Final   mom hamiltonian is "<< Hmomprime <<std::endl; | ||||
|  | ||||
|   std::cout << GridLogMessage <<"Delta   mom hamiltonian is "<< Hmomprime-Hmom <<std::endl; | ||||
|   std::cout << GridLogMessage <<"predict Delta mom hamiltonian is "<< dSm+dSm2 <<std::endl; | ||||
|  | ||||
|   std::cout << GridLogMessage << "Initial S      "<<S<<std::endl; | ||||
|   std::cout << GridLogMessage << "Final   S      "<<Sprime<<std::endl; | ||||
|   std::cout << GridLogMessage << "Delta   S      "<<Sprime-S<<std::endl; | ||||
|   std::cout << GridLogMessage << "predict delta S"<< dSpred <<std::endl; | ||||
|   std::cout << GridLogMessage << "defect "<< Sprime-S-dSpred <<std::endl; | ||||
|   std::cout << GridLogMessage << " S      "<<S<<std::endl; | ||||
|   std::cout << GridLogMessage << " Sprime "<<Sprime<<std::endl; | ||||
|   std::cout << GridLogMessage << "dS      "<<Sprime-S<<std::endl; | ||||
|   std::cout << GridLogMessage << "predict dS    "<< dSpred <<std::endl; | ||||
|   std::cout << GridLogMessage <<"dSm "<< dSm<<std::endl; | ||||
|   std::cout << GridLogMessage <<"dSm2"<< dSm2<<std::endl; | ||||
|  | ||||
|   std::cout << GridLogMessage << "Total dS    "<< Hmomprime - Hmom + Sprime - S <<std::endl; | ||||
|  | ||||
|   std::cout << GridLogMessage << "dS - dt^2 term "<< Hmomprime - Hmom + Sprime - S - dSm2 <<std::endl; | ||||
|    | ||||
|   assert( fabs(real(Sprime-S-dSpred)) < 5.0 ) ; | ||||
|  | ||||
|   std::cout<< GridLogMessage << "Done" <<std::endl; | ||||
|   | ||||
| @@ -90,8 +90,7 @@ int main (int argc, char** argv) | ||||
|   ConjugateGradient<FermionField> CG(1.0e-12, 5000); | ||||
|   ExactOneFlavourRatioPseudoFermionAction<FermionImplPolicy> Meofa(Lop, Rop, CG, CG, CG, CG, CG, Params, true); | ||||
|  | ||||
|   GridSerialRNG  sRNG; sRNG.SeedFixedIntegers(seeds4); | ||||
|   Meofa.refresh(U, sRNG, RNG5); | ||||
|   Meofa.refresh(U, RNG5); | ||||
|   RealD S = Meofa.S(U); // pdag M p | ||||
|  | ||||
|   // get the deriv of phidag M phi with respect to "U" | ||||
|   | ||||
| @@ -46,7 +46,6 @@ int main (int argc, char ** argv) | ||||
|  | ||||
|   std::vector<int> seeds({1,2,3,4}); | ||||
|  | ||||
|   GridSerialRNG sRNG; sRNG.SeedFixedIntegers({4,5,6,7}); | ||||
|   GridParallelRNG          pRNG(&Grid); | ||||
|   pRNG.SeedFixedIntegers(std::vector<int>({15,91,21,3})); | ||||
|  | ||||
| @@ -68,7 +67,7 @@ int main (int argc, char ** argv) | ||||
|   LaplacianAdjointField<PeriodicGimplR> Laplacian(&Grid, CG, LapPar, Kappa); | ||||
|   GeneralisedMomenta<PeriodicGimplR> LaplacianMomenta(&Grid, Laplacian); | ||||
|   LaplacianMomenta.M.ImportGauge(U); | ||||
|   LaplacianMomenta.MomentaDistribution(sRNG,pRNG);// fills the Momenta with the correct distr | ||||
|   LaplacianMomenta.MomentaDistribution(pRNG);// fills the Momenta with the correct distr | ||||
|    | ||||
|  | ||||
|   std::cout << std::setprecision(15); | ||||
|   | ||||
| @@ -69,14 +69,7 @@ int main (int argc, char ** argv) | ||||
|   RealD M5=1.8;  | ||||
|   RealD b=0.5; | ||||
|   RealD c=0.5; | ||||
|  | ||||
|   WilsonImplParams p; | ||||
|   p.boundary_phases[0] = 1.0; | ||||
|   p.boundary_phases[1] = 1.0; | ||||
|   p.boundary_phases[2] = 1.0; | ||||
|   p.boundary_phases[3] =- 1.0; | ||||
|    | ||||
|   MobiusFermionR Ddwf(U,*FGrid,*FrbGrid,*UGrid,*UrbGrid,mass,M5,b,c,p); | ||||
|   MobiusFermionR Ddwf(U,*FGrid,*FrbGrid,*UGrid,*UrbGrid,mass,M5,b,c); | ||||
|   Ddwf.M   (phi,Mphi); | ||||
|  | ||||
|   ComplexD S    = innerProduct(Mphi,Mphi); // pdag MdagM p | ||||
| @@ -89,43 +82,23 @@ int main (int argc, char ** argv) | ||||
|   Ddwf.MDeriv(tmp , Mphi,  phi,DaggerNo );  UdSdU=tmp; | ||||
|   Ddwf.MDeriv(tmp , phi,  Mphi,DaggerYes ); UdSdU=(UdSdU+tmp);   | ||||
|    | ||||
|   // ***************************************************************************************** | ||||
|   // *** There is a funny negative sign in all derivatives. This is - UdSdU.               *** | ||||
|   // ***                                                                                   *** | ||||
|   // *** Deriv in both Wilson gauge action and the TwoFlavour.h seems to miss a minus sign *** | ||||
|   // *** UdSdU is negated relative to what I think - call what is returned mUdSdU,         *** | ||||
|   // *** and insert minus sign                                                             *** | ||||
|   // ***************************************************************************************** | ||||
|  | ||||
|   UdSdU = - UdSdU ; // Follow sign convention of actions in Grid. Seems crazy. | ||||
|  | ||||
|   LatticeFermion Ftmp      (FGrid); | ||||
|  | ||||
|   //////////////////////////////////// | ||||
|   // Modify the gauge field a little  | ||||
|   //////////////////////////////////// | ||||
|   RealD dt = 0.001; | ||||
|   RealD Hmom = 0.0; | ||||
|   RealD Hmomprime = 0.0; | ||||
|   RealD dt = 0.0001; | ||||
|  | ||||
|   LatticeColourMatrix mommu(UGrid);  | ||||
|   LatticeColourMatrix mUdSdUmu(UGrid);  | ||||
|   LatticeColourMatrix forcemu(UGrid);  | ||||
|   LatticeGaugeField mom(UGrid);  | ||||
|   LatticeGaugeField Uprime(UGrid);  | ||||
|  | ||||
|   for(int mu=0;mu<Nd;mu++){ | ||||
|  | ||||
|     SU<Nc>::GaussianFundamentalLieAlgebraMatrix(RNG4, mommu); // Traceless antihermitian momentum; gaussian in lie alg | ||||
|     PokeIndex<LorentzIndex>(mom,mommu,mu); | ||||
|  | ||||
|     // Momentum Hamiltonian is - trace(p^2)/HMC_MOM_DENOMINATOR | ||||
|     // | ||||
|     // Integrator.h:   RealD H = - FieldImplementation::FieldSquareNorm(P)/HMC_MOMENTUM_DENOMINATOR; // - trace (P*P)/denom                                                                                       //     GaugeImplTypes.h:        Hloc += trace(Pmu * Pmu); | ||||
|     //                          Sign comes from a sneaky multiply by "i" in GaussianFundemantalLie algebra | ||||
|     //                          P is i P^a_\mu T^a, not Pa Ta | ||||
|     //  | ||||
|     // Integrator.h: H =  Hmom + sum S(action) | ||||
|     Hmom -= real(sum(trace(mommu*mommu)))/ HMC_MOMENTUM_DENOMINATOR; | ||||
|     PokeIndex<LorentzIndex>(mom,mommu,mu); | ||||
|  | ||||
|     // fourth order exponential approx | ||||
|     autoView( U_v , U, CpuRead); | ||||
| @@ -142,7 +115,6 @@ int main (int argc, char ** argv) | ||||
| 	; | ||||
|     }); | ||||
|   } | ||||
|   std::cout << GridLogMessage <<"Initial mom hamiltonian is "<< Hmom <<std::endl; | ||||
|    | ||||
|   Ddwf.ImportGauge(Uprime); | ||||
|   Ddwf.M          (phi,MphiPrime); | ||||
| @@ -153,87 +125,32 @@ int main (int argc, char ** argv) | ||||
|   // Use derivative to estimate dS | ||||
|   ////////////////////////////////////////////// | ||||
|  | ||||
|   LatticeComplex dS(UGrid); dS = Zero(); | ||||
|   LatticeComplex dSmom(UGrid); dSmom = Zero(); | ||||
|   LatticeComplex dSmom2(UGrid); dSmom2 = Zero(); | ||||
|  | ||||
|   LatticeComplex dS(UGrid); dS = Zero(); | ||||
|   for(int mu=0;mu<Nd;mu++){ | ||||
|     mommu   = PeekIndex<LorentzIndex>(UdSdU,mu); | ||||
|     mommu=Ta(mommu); | ||||
|     mommu=Ta(mommu)*2.0; | ||||
|     PokeIndex<LorentzIndex>(UdSdU,mommu,mu); | ||||
|   } | ||||
|  | ||||
|   for(int mu=0;mu<Nd;mu++){ | ||||
|  | ||||
|     mUdSdUmu= PeekIndex<LorentzIndex>(UdSdU,mu); | ||||
|     forcemu = PeekIndex<LorentzIndex>(UdSdU,mu); | ||||
|     mommu   = PeekIndex<LorentzIndex>(mom,mu); | ||||
|  | ||||
|   // | ||||
|   // Derive HMC eom: | ||||
|   // | ||||
|   // Sdot =  - 2 trace( p p^dot ) / D - trace( p [ mUdSdU - h.c. ] ) = 0  | ||||
|   // | ||||
|   // | ||||
|   // Sdot = 0 = - 2 trace( p p^dot ) / D - 2 trace( p Ta( mUdSdU ) = 0 | ||||
|   // | ||||
|   // EOM:  | ||||
|   // | ||||
|   // pdot = - D Ta( mUdSdU ) -- source of sign is the "funny sign" above | ||||
|   // | ||||
|   // dSqcd_dt  = - 2.0*trace(mommu* Ta(mUdSdU) )*dt -- i.e. mUdSdU with adjoint term -> force has a 2x implicit | ||||
|   // | ||||
|   // dH_mom/dt = - 2 trace (p pdot)/Denom   | ||||
|   // | ||||
|   // dH_tot / dt = 0 <= pdot = - Denom * mUdSdU  | ||||
|   // | ||||
|   // dH_mom/dt = 2 trace (p mUdSdU )  | ||||
|   // | ||||
|   // True Momentum delta H has a dt^2 piece | ||||
|   // | ||||
|   // dSmom = [ trace mom*mom - trace ( (mom-Denom*f*dt)(mom-Denom*f*dt) ) ] / Denom | ||||
|   //       = 2*trace(mom*f) dt  - Denom*dt*dt * trace(f*f). | ||||
|   //       = dSmom + dSmom2 | ||||
|   // | ||||
|      | ||||
|     dS     = dS - 2.0*trace(mommu*mUdSdUmu)*dt;   // U and Udagger derivs hence 2x. | ||||
|  | ||||
|     dSmom  = dSmom  + 2.0*trace(mommu*mUdSdUmu) * dt;  // this 2.0 coms from derivative of p^2  | ||||
|      | ||||
|     dSmom2 = dSmom2 - trace(mUdSdUmu*mUdSdUmu) * dt*dt* HMC_MOMENTUM_DENOMINATOR; // Remnant | ||||
|  | ||||
|     mommu = mommu - mUdSdUmu * dt* HMC_MOMENTUM_DENOMINATOR;;  | ||||
|  | ||||
|     Hmomprime -= real(sum(trace(mommu*mommu))) / HMC_MOMENTUM_DENOMINATOR; | ||||
|     // Update PF action density | ||||
|     dS = dS+trace(mommu*forcemu)*dt; | ||||
|  | ||||
|   } | ||||
|  | ||||
|   ComplexD dSpred    = sum(dS); | ||||
|   ComplexD dSm       = sum(dSmom); | ||||
|   ComplexD dSm2      = sum(dSmom2); | ||||
|  | ||||
|   std::cout << GridLogMessage <<"dSm "<< dSm<<std::endl; | ||||
|   std::cout << GridLogMessage <<"dSm2 "<< dSm2<<std::endl; | ||||
|  | ||||
|   std::cout << GridLogMessage <<"Initial mom hamiltonian is "<< Hmom <<std::endl; | ||||
|   std::cout << GridLogMessage <<"Final   mom hamiltonian is "<< Hmomprime <<std::endl; | ||||
|  | ||||
|   std::cout << GridLogMessage <<"Delta   mom hamiltonian is "<< Hmomprime-Hmom <<std::endl; | ||||
|   std::cout << GridLogMessage <<"predict Delta mom hamiltonian is "<< dSm+dSm2 <<std::endl; | ||||
|    | ||||
|   std::cout << GridLogMessage << "Initial S      "<<S<<std::endl; | ||||
|   std::cout << GridLogMessage << "Final   S      "<<Sprime<<std::endl; | ||||
|   std::cout << GridLogMessage << "Delta   S      "<<Sprime-S<<std::endl; | ||||
|   std::cout << GridLogMessage << "predict delta S"<< dSpred <<std::endl; | ||||
|   std::cout << GridLogMessage << "defect "<< Sprime-S-dSpred <<std::endl; | ||||
|  | ||||
|   std::cout << GridLogMessage << "Total dS    "<< Hmomprime - Hmom + Sprime - S <<std::endl; | ||||
|  | ||||
|   std::cout << GridLogMessage << "dS - dt^2 term "<< Hmomprime - Hmom + Sprime - S - dSm2 <<std::endl; | ||||
|   std::cout << GridLogMessage << " -- S         "<<S<<std::endl; | ||||
|   std::cout << GridLogMessage << " -- Sprime    "<<Sprime<<std::endl; | ||||
|   std::cout << GridLogMessage << "dS            "<<Sprime-S<<std::endl; | ||||
|   std::cout << GridLogMessage << "predict dS    "<< dSpred <<std::endl; | ||||
|  | ||||
|   assert( fabs(real(Sprime-S-dSpred)) < 1.0 ) ; | ||||
|  | ||||
|  | ||||
|    | ||||
|   std::cout<< GridLogMessage << "Done" <<std::endl; | ||||
|   Grid_finalize(); | ||||
| } | ||||
|   | ||||
| @@ -88,8 +88,7 @@ int main (int argc, char** argv) | ||||
|   ConjugateGradient<LatticeFermion> CG(1.0e-12, 5000); | ||||
|   ExactOneFlavourRatioPseudoFermionAction<WilsonImplR> Meofa(Lop, Rop, CG, CG, CG, CG, CG, Params, false); | ||||
|  | ||||
|   GridSerialRNG  sRNG; sRNG.SeedFixedIntegers(seeds4); | ||||
|   Meofa.refresh(U, sRNG, RNG5 ); | ||||
|   Meofa.refresh(U, RNG5); | ||||
|   RealD S = Meofa.S(U); // pdag M p | ||||
|  | ||||
|   // get the deriv of phidag M phi with respect to "U" | ||||
|   | ||||
| @@ -93,8 +93,7 @@ int main (int argc, char** argv) | ||||
|   ConjugateGradient<FermionField> CG(1.0e-12, 5000); | ||||
|   ExactOneFlavourRatioPseudoFermionAction<FermionImplPolicy> Meofa(Lop, Rop, CG, CG, CG, CG, CG, Params, false); | ||||
|  | ||||
|   GridSerialRNG  sRNG; sRNG.SeedFixedIntegers(seeds4); | ||||
|   Meofa.refresh(U, sRNG, RNG5 ); | ||||
|   Meofa.refresh(U, RNG5); | ||||
|   RealD S = Meofa.S(U); // pdag M p | ||||
|  | ||||
|   // get the deriv of phidag M phi with respect to "U" | ||||
|   | ||||
| @@ -1,154 +0,0 @@ | ||||
|     /************************************************************************************* | ||||
|  | ||||
|     Grid physics library, www.github.com/paboyle/Grid  | ||||
|  | ||||
|     Source file: ./tests/Test_wilson_force.cc | ||||
|  | ||||
|     Copyright (C) 2015 | ||||
|  | ||||
| Author: Christopher Kelly <ckelly@bnl.gov> | ||||
|  | ||||
|     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 | ||||
|     the Free Software Foundation; either version 2 of the License, or | ||||
|     (at your option) any later version. | ||||
|  | ||||
|     This program is distributed in the hope that it will be useful, | ||||
|     but WITHOUT ANY WARRANTY; without even the implied warranty of | ||||
|     MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE.  See the | ||||
|     GNU General Public License for more details. | ||||
|  | ||||
|     You should have received a copy of the GNU General Public License along | ||||
|     with this program; if not, write to the Free Software Foundation, Inc., | ||||
|     51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. | ||||
|  | ||||
|     See the full license in the file "LICENSE" in the top level distribution directory | ||||
|     *************************************************************************************/ | ||||
|     /*  END LEGAL */ | ||||
| #include <Grid/Grid.h> | ||||
|  | ||||
| using namespace std; | ||||
| using namespace Grid; | ||||
|  | ||||
| //Get the mu-directected links on the upper boundary and the bulk remainder | ||||
| template<typename Field> | ||||
| void getLinksBoundaryBulk(Field &bound, Field &bulk,  Field &from, const Coordinate &latt_size){ | ||||
|   bound = Zero(); bulk = Zero(); | ||||
|   for(int mu=0;mu<Nd;mu++){ | ||||
|     LatticeInteger mucoor(bound.Grid()); | ||||
|     LatticeCoordinate(mucoor, mu); | ||||
|  | ||||
|     bound = where( mucoor == (Integer)(latt_size[mu] - 1), from, bound ); | ||||
|     bulk = where( mucoor != (Integer)(latt_size[mu] - 1), from, bulk ); | ||||
|   } | ||||
| } | ||||
|  | ||||
|  | ||||
| int main (int argc, char ** argv) | ||||
| { | ||||
|   Grid_init(&argc,&argv); | ||||
|  | ||||
|   Coordinate latt_size   = GridDefaultLatt(); | ||||
|   Coordinate simd_layout = GridDefaultSimd(Nd,vComplex::Nsimd()); | ||||
|   Coordinate mpi_layout  = GridDefaultMpi(); | ||||
|  | ||||
|   GridCartesian               Grid(latt_size,simd_layout,mpi_layout); | ||||
|   GridRedBlackCartesian     RBGrid(&Grid); | ||||
|  | ||||
|   int threads = GridThread::GetThreads(); | ||||
|   std::cout<<GridLogMessage << "Grid is setup to use "<<threads<<" threads"<<std::endl; | ||||
|  | ||||
|   std::vector<int> seeds({1,2,3,4}); | ||||
|  | ||||
|   GridParallelRNG          pRNG(&Grid); | ||||
|   pRNG.SeedFixedIntegers(seeds); | ||||
|  | ||||
|   typedef PeriodicGimplR Gimpl; | ||||
|   typedef WilsonGaugeAction<Gimpl> GaugeAction; | ||||
|   typedef NoHirep Representation; //fundamental | ||||
|   typedef NoSmearing<Gimpl> Smearing; | ||||
|   typedef MinimumNorm2<Gimpl, Smearing> Omelyan; | ||||
|   typedef Gimpl::Field Field; | ||||
|   typedef MomentumFilterApplyPhase<Field> Filter; | ||||
|   Filter filter(&Grid); | ||||
|    | ||||
|   //Setup a filter that disables link update on links passing through the global lattice boundary | ||||
|   typedef Filter::LatticeLorentzScalarType MaskType; | ||||
|   typedef Filter::LorentzScalarType MaskSiteType; | ||||
|  | ||||
|   MaskSiteType zero, one; | ||||
|   for(int mu=0;mu<Nd;mu++){ | ||||
|     zero(mu)()() = 0.; | ||||
|     one(mu)()() = 1.; | ||||
|   } | ||||
|   MaskType zeroField(&Grid), oneField(&Grid); | ||||
|   zeroField = zero; | ||||
|   oneField = one; | ||||
|  | ||||
|    | ||||
|   filter.phase = oneField; //make every site 1.0 | ||||
|  | ||||
|   //Zero mu-directed links at upper boundary | ||||
|   for(int mu=0;mu<Nd;mu++){ | ||||
|     LatticeInteger mucoor(&Grid); | ||||
|     LatticeCoordinate(mucoor, mu); | ||||
|      | ||||
|     filter.phase = where( mucoor == (Integer)(latt_size[mu] - 1) , zeroField, filter.phase ); | ||||
|   } | ||||
|  | ||||
|   //Start with a random gauge field | ||||
|   Field U(&Grid); | ||||
|   SU<Nc>::HotConfiguration(pRNG,U); | ||||
|  | ||||
|   //Get the original links on the bulk and boundary for later use | ||||
|   Field Ubnd_orig(&Grid), Ubulk_orig(&Grid); | ||||
|   getLinksBoundaryBulk(Ubnd_orig, Ubulk_orig, U, latt_size); | ||||
|  | ||||
|   ActionSet<Field,Representation> actions(1);   | ||||
|   double beta=6; | ||||
|   GaugeAction gauge_action(beta); | ||||
|   actions[0].push_back(&gauge_action); | ||||
|  | ||||
|   Smearing smear; | ||||
|   IntegratorParameters params(1,1.); //1 MD step | ||||
|   Omelyan integrator(&Grid, params, actions, smear); | ||||
|    | ||||
|   integrator.setMomentumFilter(filter); | ||||
|  | ||||
|   integrator.refresh(U, pRNG); //doesn't actually change the gauge field | ||||
|  | ||||
|   //Check the momentum is zero on the boundary | ||||
|   const auto &P = integrator.getMomentum(); | ||||
|   Field Pbnd(&Grid), Pbulk(&Grid); | ||||
|   getLinksBoundaryBulk(Pbnd, Pbulk, const_cast<Field&>(P), latt_size); | ||||
|  | ||||
|   RealD Pbnd_nrm = norm2(Pbnd); //expect zero | ||||
|   std::cout << GridLogMessage << "After refresh, norm2 of mu-directed conjugate momentum on boundary is: " << Pbnd_nrm << " (expect 0)" << std::endl; | ||||
|   RealD Pbulk_nrm = norm2(Pbulk); //expect non-zero | ||||
|   std::cout << GridLogMessage << "After refresh, norm2 of bulk conjugate momentum is: " << Pbulk_nrm << " (expect non-zero)" << std::endl; | ||||
|  | ||||
|   //Evolve the gauge field | ||||
|   integrator.integrate(U); | ||||
|  | ||||
|   //Check momentum is still zero on boundary | ||||
|   getLinksBoundaryBulk(Pbnd, Pbulk, const_cast<Field&>(P), latt_size); | ||||
|    | ||||
|   Pbnd_nrm = norm2(Pbnd); //expect zero | ||||
|   std::cout << GridLogMessage << "After integrate, norm2 of mu-directed conjugate momentum on boundary is: " << Pbnd_nrm << " (expect 0)" << std::endl; | ||||
|   Pbulk_nrm = norm2(Pbulk); //expect non-zero | ||||
|   std::cout << GridLogMessage << "After integrate, norm2 of bulk conjugate momentum is: " << Pbulk_nrm << " (expect non-zero)" << std::endl; | ||||
|  | ||||
|   //Get the new bulk and bound links | ||||
|   Field Ubnd_new(&Grid), Ubulk_new(&Grid); | ||||
|   getLinksBoundaryBulk(Ubnd_new, Ubulk_new, U, latt_size); | ||||
|  | ||||
|   Field Ubnd_diff = Ubnd_new - Ubnd_orig; | ||||
|   Field Ubulk_diff = Ubulk_new - Ubulk_orig; | ||||
|  | ||||
|   RealD Ubnd_change = norm2( Ubnd_diff ); | ||||
|   RealD Ubulk_change = norm2( Ubulk_diff ); | ||||
|   std::cout << GridLogMessage << "After integrate, norm2 of change in mu-directed boundary links is : " << Ubnd_change << " (expect 0)" << std::endl; | ||||
|   std::cout << GridLogMessage << "After integrate, norm2 of change in bulk links is : " << Ubulk_change << " (expect non-zero)" << std::endl; | ||||
|  | ||||
|   Grid_finalize(); | ||||
| } | ||||
		Reference in New Issue
	
	Block a user