mirror of
				https://github.com/paboyle/Grid.git
				synced 2025-10-25 10:09:34 +01:00 
			
		
		
		
	Compare commits
	
		
			3 Commits
		
	
	
		
			specflow
			...
			feature/ft
		
	
	| Author | SHA1 | Date | |
|---|---|---|---|
|  | bffd30abec | ||
|  | da919949f9 | ||
|  | b12b4fdaff | 
| @@ -91,6 +91,7 @@ public: | ||||
|   //////////////////////////////////////////////////////////////// | ||||
|   virtual int CheckerBoarded(int dim)=0; | ||||
|   virtual int CheckerBoard(const Coordinate &site)=0; | ||||
|   virtual int CheckerDim(void){ return 0; }; | ||||
|   virtual int CheckerBoardDestination(int source_cb,int shift,int dim)=0; | ||||
|   virtual int CheckerBoardShift(int source_cb,int dim,int shift,int osite)=0; | ||||
|   virtual int CheckerBoardShiftForCB(int source_cb,int dim,int shift,int cb)=0; | ||||
|   | ||||
| @@ -60,6 +60,7 @@ public: | ||||
|   int              _checker_dim; | ||||
|   std::vector<int> _checker_board; | ||||
|  | ||||
|   virtual int CheckerDim(void){ return _checker_dim; }; | ||||
|   virtual int CheckerBoarded(int dim){ | ||||
|     if( dim==_checker_dim) return 1; | ||||
|     else return 0; | ||||
|   | ||||
| @@ -42,50 +42,21 @@ inline void subdivides(GridBase *coarse,GridBase *fine) | ||||
|     assert((fine->_rdimensions[d] / coarse->_rdimensions[d])* coarse->_rdimensions[d]==fine->_rdimensions[d]);  | ||||
|   } | ||||
| } | ||||
|  | ||||
|   | ||||
| //////////////////////////////////////////////////////////////////////////////////////////// | ||||
| // remove and insert a half checkerboard | ||||
| //////////////////////////////////////////////////////////////////////////////////////////// | ||||
|  | ||||
| template<class vobj> inline void pickCheckerboard(int cb,Lattice<vobj> &half,const Lattice<vobj> &full) | ||||
| { | ||||
|   half.Checkerboard() = cb; | ||||
|  | ||||
|   autoView( half_v, half, CpuWrite); | ||||
|   autoView( full_v, full, CpuRead); | ||||
|   thread_for(ss, full.Grid()->oSites(),{ | ||||
|     int cbos; | ||||
|     Coordinate coor; | ||||
|     full.Grid()->oCoorFromOindex(coor,ss); | ||||
|     cbos=half.Grid()->CheckerBoard(coor); | ||||
|  | ||||
|     if (cbos==cb) { | ||||
|       int ssh=half.Grid()->oIndex(coor); | ||||
|       half_v[ssh] = full_v[ss]; | ||||
|     } | ||||
|   }); | ||||
|   acceleratorPickCheckerboard(cb,half,full); | ||||
| } | ||||
| template<class vobj> inline void setCheckerboard(Lattice<vobj> &full,const Lattice<vobj> &half) | ||||
| { | ||||
|   int cb = half.Checkerboard(); | ||||
|   autoView( half_v , half, CpuRead); | ||||
|   autoView( full_v , full, CpuWrite); | ||||
|   thread_for(ss,full.Grid()->oSites(),{ | ||||
|  | ||||
|     Coordinate coor; | ||||
|     int cbos; | ||||
|  | ||||
|     full.Grid()->oCoorFromOindex(coor,ss); | ||||
|     cbos=half.Grid()->CheckerBoard(coor); | ||||
|        | ||||
|     if (cbos==cb) { | ||||
|       int ssh=half.Grid()->oIndex(coor); | ||||
|       full_v[ss]=half_v[ssh]; | ||||
|     } | ||||
|   }); | ||||
|   acceleratorSetCheckerboard(full,half); | ||||
| } | ||||
|  | ||||
| template<class vobj> inline void acceleratorPickCheckerboard(int cb,Lattice<vobj> &half,const Lattice<vobj> &full, int checker_dim_half=0) | ||||
| template<class vobj> inline void acceleratorPickCheckerboard(int cb,Lattice<vobj> &half,const Lattice<vobj> &full, int dummy=0) | ||||
| { | ||||
|   half.Checkerboard() = cb; | ||||
|   autoView(half_v, half, AcceleratorWrite); | ||||
| @@ -95,6 +66,7 @@ template<class vobj> inline void acceleratorPickCheckerboard(int cb,Lattice<vobj | ||||
|   unsigned long ndim_half          = half.Grid()->_ndimension; | ||||
|   Coordinate checker_dim_mask_half = half.Grid()->_checker_dim_mask; | ||||
|   Coordinate ostride_half          = half.Grid()->_ostride; | ||||
|   int checker_dim_half             = half.Grid()->CheckerDim(); | ||||
|   accelerator_for(ss, full.Grid()->oSites(),full.Grid()->Nsimd(),{ | ||||
|      | ||||
|     Coordinate coor; | ||||
| @@ -119,7 +91,7 @@ template<class vobj> inline void acceleratorPickCheckerboard(int cb,Lattice<vobj | ||||
|     } | ||||
|   }); | ||||
| } | ||||
| template<class vobj> inline void acceleratorSetCheckerboard(Lattice<vobj> &full,const Lattice<vobj> &half, int checker_dim_half=0) | ||||
| template<class vobj> inline void acceleratorSetCheckerboard(Lattice<vobj> &full,const Lattice<vobj> &half, int dummy=0) | ||||
| { | ||||
|   int cb = half.Checkerboard(); | ||||
|   autoView(half_v , half, AcceleratorRead); | ||||
| @@ -129,6 +101,7 @@ template<class vobj> inline void acceleratorSetCheckerboard(Lattice<vobj> &full, | ||||
|   unsigned long ndim_half          = half.Grid()->_ndimension; | ||||
|   Coordinate checker_dim_mask_half = half.Grid()->_checker_dim_mask; | ||||
|   Coordinate ostride_half          = half.Grid()->_ostride; | ||||
|   int checker_dim_half             = half.Grid()->CheckerDim(); | ||||
|   accelerator_for(ss,full.Grid()->oSites(),full.Grid()->Nsimd(),{ | ||||
|  | ||||
|     Coordinate coor; | ||||
|   | ||||
| @@ -32,7 +32,9 @@ private: | ||||
|   //  Smear_Stout<Gimpl> *StoutSmearing; | ||||
|   //  std::vector<GaugeField> SmearedSet; | ||||
|    | ||||
|   GridRedBlackCartesian * UrbGrid; // keep a copy of the redblack grid for life of object | ||||
|   std::vector<LatticeLorentzComplex> masks; | ||||
|   std::vector<int> cbs; | ||||
|  | ||||
|   typedef typename SU3Adjoint::AMatrix AdjMatrix; | ||||
|   typedef typename SU3Adjoint::LatticeAdjMatrix  AdjMatrixField; | ||||
| @@ -147,6 +149,25 @@ private: | ||||
|     } | ||||
|     pokeLorentz(Fdet, Fdet_pol, nu); | ||||
|   } | ||||
|  | ||||
|   void Compute_MpInvJx_dNxxdSy(int cb, | ||||
| 			       const GaugeLinkField &PlaqL, | ||||
| 			       const GaugeLinkField &PlaqR, | ||||
| 			       AdjMatrixField MpInvJx, | ||||
| 			       AdjVectorField &Fdet2 ) | ||||
|   { | ||||
|     GaugeLinkField PlaqLeo(UrbGrid); | ||||
|     GaugeLinkField PlaqReo(UrbGrid); | ||||
|     AdjMatrixField MpInvJxeo(UrbGrid); | ||||
|     AdjVectorField Fdet2eo(UrbGrid); | ||||
|     pickCheckerboard(cb,PlaqLeo,PlaqL); | ||||
|     pickCheckerboard(cb,PlaqReo,PlaqR); | ||||
|     pickCheckerboard(cb,MpInvJxeo,MpInvJx); | ||||
|     Fdet2eo.Checkerboard()=cb; | ||||
|     Compute_MpInvJx_dNxxdSy(PlaqLeo,PlaqReo,MpInvJxeo,Fdet2eo); | ||||
|     setCheckerboard(Fdet2,Fdet2eo); | ||||
|   } | ||||
|    | ||||
|   void Compute_MpInvJx_dNxxdSy(const GaugeLinkField &PlaqL,const GaugeLinkField &PlaqR, AdjMatrixField MpInvJx,AdjVectorField &Fdet2 ) | ||||
|   { | ||||
|     GaugeLinkField UtaU(PlaqL.Grid()); | ||||
| @@ -278,8 +299,9 @@ public: | ||||
|     //////////////////////////////////////////////////////////////////////////////// | ||||
|     // Mask the gauge field | ||||
|     //////////////////////////////////////////////////////////////////////////////// | ||||
|     int cb = cbs[smr]; | ||||
|     auto mask=PeekIndex<LorentzIndex>(masks[smr],mu); // the cb mask | ||||
|  | ||||
|      | ||||
|     Umsk = U; | ||||
|     ApplyMask(Umsk,smr); | ||||
|     Utmp = peekLorentz(Umsk,mu); | ||||
| @@ -442,7 +464,7 @@ public: | ||||
|     AdjMatrixField MpInvJx_nu(grid); | ||||
|     MpInvJx = (-1.0)*MpAdInv * JxAd;// rho is on the plaq factor | ||||
|  | ||||
|     Compute_MpInvJx_dNxxdSy(PlaqL,PlaqR,MpInvJx,FdetV); | ||||
|     Compute_MpInvJx_dNxxdSy(cb,PlaqL,PlaqR,MpInvJx,FdetV); | ||||
|     Fdet2_mu=FdetV; | ||||
|     Fdet1_mu=Zero(); | ||||
|      | ||||
| @@ -499,7 +521,7 @@ public: | ||||
|  | ||||
| 	time=-usecond(); | ||||
| 	PlaqR=(-1.0)*PlaqR; | ||||
| 	Compute_MpInvJx_dNxxdSy(PlaqL,PlaqR,MpInvJx,FdetV); | ||||
| 	Compute_MpInvJx_dNxxdSy(cb,PlaqL,PlaqR,MpInvJx,FdetV); | ||||
| 	Fdet2_nu = FdetV; | ||||
| 	time+=usecond(); | ||||
| 	std::cout << GridLogMessage << "Compute_MpInvJx_dNxxSy (occurs 6x) took "<<time<< " us"<<std::endl; | ||||
| @@ -520,7 +542,7 @@ public: | ||||
| 	 | ||||
|  | ||||
| 	MpInvJx_nu = Cshift(MpInvJx,mu,-1); | ||||
| 	Compute_MpInvJx_dNxxdSy(PlaqL,PlaqR,MpInvJx_nu,FdetV); | ||||
| 	Compute_MpInvJx_dNxxdSy(cb,PlaqL,PlaqR,MpInvJx_nu,FdetV); | ||||
| 	Fdet2_nu = Fdet2_nu+FdetV; | ||||
| 	 | ||||
| 	///////////////// -ve nu ///////////////// | ||||
| @@ -539,7 +561,7 @@ public: | ||||
| 	Fdet1_nu = Fdet1_nu + transpose(Nxy)*dJdXe_nMpInv_y; | ||||
|  | ||||
| 	MpInvJx_nu = Cshift(MpInvJx,nu,1); | ||||
| 	Compute_MpInvJx_dNxxdSy(PlaqL,PlaqR,MpInvJx_nu,FdetV); | ||||
| 	Compute_MpInvJx_dNxxdSy(cb,PlaqL,PlaqR,MpInvJx_nu,FdetV); | ||||
| 	Fdet2_nu = Fdet2_nu+FdetV; | ||||
| 	 | ||||
| 	// x== | ||||
| @@ -560,7 +582,7 @@ public: | ||||
|  | ||||
| 	MpInvJx_nu = Cshift(MpInvJx,mu,-1); | ||||
| 	MpInvJx_nu = Cshift(MpInvJx_nu,nu,1); | ||||
| 	Compute_MpInvJx_dNxxdSy(PlaqL,PlaqR,MpInvJx_nu,FdetV); | ||||
| 	Compute_MpInvJx_dNxxdSy(cb,PlaqL,PlaqR,MpInvJx_nu,FdetV); | ||||
| 	Fdet2_nu = Fdet2_nu+FdetV; | ||||
|  | ||||
| 	///////////////////////////////////////////////////////////////////// | ||||
| @@ -589,7 +611,7 @@ public: | ||||
|  | ||||
| 	MpInvJx_nu = Cshift(MpInvJx,nu,-1); | ||||
|  | ||||
| 	Compute_MpInvJx_dNxxdSy(PlaqL,PlaqR,MpInvJx_nu,FdetV); | ||||
| 	Compute_MpInvJx_dNxxdSy(cb,PlaqL,PlaqR,MpInvJx_nu,FdetV); | ||||
| 	Fdet2_mu = Fdet2_mu+FdetV; | ||||
|  | ||||
| 	//  __ | ||||
| @@ -609,7 +631,7 @@ public: | ||||
|  | ||||
| 	MpInvJx_nu = Cshift(MpInvJx,nu,1); | ||||
|  | ||||
| 	Compute_MpInvJx_dNxxdSy(PlaqL,PlaqR,MpInvJx_nu,FdetV); | ||||
| 	Compute_MpInvJx_dNxxdSy(cb,PlaqL,PlaqR,MpInvJx_nu,FdetV); | ||||
| 	Fdet2_mu = Fdet2_mu+FdetV; | ||||
| 	 | ||||
|       } | ||||
| @@ -931,6 +953,10 @@ private: | ||||
| public: | ||||
|  | ||||
|   /* Standard constructor */ | ||||
|   virtual ~SmearedConfigurationMasked() | ||||
|   { | ||||
|     delete UrbGrid; | ||||
|   } | ||||
|   SmearedConfigurationMasked(GridCartesian* _UGrid, unsigned int Nsmear, Smear_Stout<Gimpl>& Stout) | ||||
|     : SmearedConfiguration<Gimpl>(_UGrid, Nsmear,Stout) | ||||
|   { | ||||
| @@ -939,7 +965,6 @@ public: | ||||
|     // was resized in base class | ||||
|     assert(this->SmearedSet.size()==Nsmear); | ||||
|      | ||||
|     GridRedBlackCartesian * UrbGrid; | ||||
|     UrbGrid = SpaceTimeGrid::makeFourDimRedBlackGrid(_UGrid); | ||||
|     LatticeComplex one(_UGrid); one = ComplexD(1.0,0.0); | ||||
|     LatticeComplex tmp(_UGrid); | ||||
| @@ -947,10 +972,11 @@ public: | ||||
|     for (unsigned int i = 0; i < this->smearingLevels; ++i) { | ||||
|  | ||||
|       masks.push_back(*(new LatticeLorentzComplex(_UGrid))); | ||||
|  | ||||
|       int mu= (i/2) %Nd; | ||||
|       int cb= (i%2); | ||||
|       LatticeComplex tmpcb(UrbGrid); | ||||
|  | ||||
|       cbs.push_back(cb); | ||||
| 	 | ||||
|       masks[i]=Zero(); | ||||
|       //////////////////// | ||||
| @@ -962,7 +988,6 @@ public: | ||||
|       PokeIndex<LorentzIndex>(masks[i],tmp, mu); | ||||
| 	 | ||||
|     } | ||||
|     delete UrbGrid; | ||||
|   } | ||||
|    | ||||
|   virtual void smeared_force(GaugeField &SigmaTilde)  | ||||
|   | ||||
| @@ -418,32 +418,32 @@ static void LieAlgebraProject(LatticeAlgebraMatrix &out,const LatticeMatrix &in, | ||||
|   int hNNm1= NNm1/2; | ||||
|   RealD sqrt_2 = sqrt(2.0); | ||||
|   Complex ci(0.0,1.0); | ||||
|   for(int su2Index=0;su2Index<hNNm1;su2Index++){ | ||||
|     int i1, i2; | ||||
|     su2SubGroupIndex(i1, i2, su2Index); | ||||
|     int ax = su2Index*2; | ||||
|     int ay = su2Index*2+1; | ||||
|     accelerator_for(ss,grid->oSites(),1,{ | ||||
|  | ||||
|   const int nsimd=  Matrix::Nsimd(); | ||||
|   accelerator_for(ss,grid->oSites(),nsimd,{ | ||||
|       for(int su2Index=0;su2Index<hNNm1;su2Index++){ | ||||
| 	int i1, i2; | ||||
| 	su2SubGroupIndex(i1, i2, su2Index); | ||||
| 	int ax = su2Index*2; | ||||
| 	int ay = su2Index*2+1; | ||||
| 	// in is traceless ANTI-hermitian whereas Grid generators are Hermitian. | ||||
| 	// trace( Ta x Ci in) | ||||
| 	// Bet I need to move to real part with mult by -i | ||||
| 	out_v[ss]()()(ax,b) = 0.5*(real(in_v[ss]()()(i2,i1)) - real(in_v[ss]()()(i1,i2))); | ||||
| 	out_v[ss]()()(ay,b) = 0.5*(imag(in_v[ss]()()(i1,i2)) + imag(in_v[ss]()()(i2,i1))); | ||||
|       }); | ||||
|   } | ||||
|   for(int diagIndex=0;diagIndex<N-1;diagIndex++){ | ||||
|     int k = diagIndex + 1; // diagIndex starts from 0 | ||||
|     int a = NNm1+diagIndex; | ||||
|     RealD scale = 1.0/sqrt(2.0*k*(k+1)); | ||||
|     accelerator_for(ss,grid->oSites(),vComplex::Nsimd(),{ | ||||
| 	auto tmp = in_v[ss]()()(0,0); | ||||
| 	coalescedWrite(out_v[ss]()()(ax,b),0.5*(real(in_v(ss)()()(i2,i1)) - real(in_v(ss)()()(i1,i2)))); | ||||
| 	coalescedWrite(out_v[ss]()()(ay,b),0.5*(imag(in_v(ss)()()(i1,i2)) + imag(in_v(ss)()()(i2,i1)))); | ||||
|       } | ||||
|       for(int diagIndex=0;diagIndex<N-1;diagIndex++){ | ||||
| 	int k = diagIndex + 1; // diagIndex starts from 0 | ||||
| 	int a = NNm1+diagIndex; | ||||
| 	RealD scale = 1.0/sqrt(2.0*k*(k+1)); | ||||
| 	auto tmp = in_v(ss)()()(0,0); | ||||
| 	for(int i=1;i<k;i++){ | ||||
| 	  tmp=tmp+in_v[ss]()()(i,i); | ||||
| 	  tmp=tmp+in_v(ss)()()(i,i); | ||||
| 	} | ||||
| 	tmp = tmp - in_v[ss]()()(k,k)*k; | ||||
| 	out_v[ss]()()(a,b) =imag(tmp) * scale; | ||||
|       }); | ||||
|     } | ||||
| 	tmp = tmp - in_v(ss)()()(k,k)*k; | ||||
| 	coalescedWrite(out_v[ss]()()(a,b),imag(tmp) * scale); | ||||
|       } | ||||
|     }); | ||||
| } | ||||
|  | ||||
|    | ||||
|   | ||||
| @@ -118,7 +118,7 @@ static void generatorDiagonal(int diagIndex, iGroupMatrix<cplx> &ta) { | ||||
| //////////////////////////////////////////////////////////////////////// | ||||
| // Map a su2 subgroup number to the pair of rows that are non zero | ||||
| //////////////////////////////////////////////////////////////////////// | ||||
| static void su2SubGroupIndex(int &i1, int &i2, int su2_index, GroupName::SU) { | ||||
| static accelerator_inline void su2SubGroupIndex(int &i1, int &i2, int su2_index, GroupName::SU) { | ||||
|   assert((su2_index >= 0) && (su2_index < (ncolour * (ncolour - 1)) / 2)); | ||||
|  | ||||
|   int spare = su2_index; | ||||
|   | ||||
		Reference in New Issue
	
	Block a user