mirror of
				https://github.com/paboyle/Grid.git
				synced 2025-10-24 17:54:47 +01:00 
			
		
		
		
	Check-in of working Mobius EOFA class and tests
This commit is contained in:
		| @@ -265,9 +265,9 @@ typedef MobiusFermion<GparityWilsonImplRL> GparityMobiusFermionRL; | ||||
| typedef MobiusFermion<GparityWilsonImplFH> GparityMobiusFermionFH; | ||||
| typedef MobiusFermion<GparityWilsonImplDF> GparityMobiusFermionDF; | ||||
|  | ||||
| typedef MobiusEOFAFermion<GparityWilsonImplR> GparityMobiusFermionR; | ||||
| typedef MobiusEOFAFermion<GparityWilsonImplF> GparityMobiusFermionF; | ||||
| typedef MobiusEOFAFermion<GparityWilsonImplD> GparityMobiusFermionD; | ||||
| typedef MobiusEOFAFermion<GparityWilsonImplR> GparityMobiusEOFAFermionR; | ||||
| typedef MobiusEOFAFermion<GparityWilsonImplF> GparityMobiusEOFAFermionF; | ||||
| typedef MobiusEOFAFermion<GparityWilsonImplD> GparityMobiusEOFAFermionD; | ||||
|  | ||||
| typedef MobiusEOFAFermion<GparityWilsonImplRL> GparityMobiusEOFAFermionRL; | ||||
| typedef MobiusEOFAFermion<GparityWilsonImplFH> GparityMobiusEOFAFermionFH; | ||||
|   | ||||
| @@ -142,7 +142,7 @@ namespace QCD { | ||||
|  | ||||
|       RealD DtInv_p(0.0), DtInv_m(0.0); | ||||
|       RealD N = std::pow(c+d,Ls) + m*std::pow(c-d,Ls); | ||||
|       FermionField tmp = zero; | ||||
|       FermionField tmp(this->FermionGrid()); | ||||
|  | ||||
|       for(int s=0; s<Ls; ++s){ | ||||
|       for(int sp=0; sp<Ls; ++sp){ | ||||
| @@ -152,14 +152,13 @@ namespace QCD { | ||||
|         DtInv_m = m * std::pow(-1.0,sp-s+1) * std::pow(c-d,Ls+sp-s) / std::pow(c+d,sp-s+1) / N; | ||||
|         DtInv_m += (s > sp) ? 0.0 : std::pow(-1.0,sp-s) * std::pow(c-d,sp-s) / std::pow(c+d,sp-s+1); | ||||
|  | ||||
|         if(dag){ | ||||
|           RealD tmp(DtInv_p); | ||||
|           DtInv_p = DtInv_m; | ||||
|           DtInv_m = tmp; | ||||
|         } | ||||
|  | ||||
|         if(sp == 0){ | ||||
|           axpby_ssp_pplus (tmp, 0.0, tmp, DtInv_p, psi, s, sp); | ||||
|           axpby_ssp_pminus(tmp, 0.0, tmp, DtInv_m, psi, s, sp); | ||||
|         } else { | ||||
|           axpby_ssp_pplus (tmp, 1.0, tmp, DtInv_p, psi, s, sp); | ||||
|           axpby_ssp_pminus(tmp, 1.0, tmp, DtInv_m, psi, s, sp); | ||||
|         } | ||||
|  | ||||
|       }} | ||||
|     } | ||||
| @@ -220,8 +219,8 @@ namespace QCD { | ||||
|       int Ls = this->Ls; | ||||
|  | ||||
|       std::vector<Coeff_t> diag(Ls,1.0); | ||||
|       std::vector<Coeff_t> upper(Ls,-1.0); upper[Ls-1] = this->mq1 + shiftp; | ||||
|       std::vector<Coeff_t> lower(Ls,-1.0); lower[0]    = this->mq1 + shiftm; | ||||
|       std::vector<Coeff_t> upper(Ls,-1.0);  upper[Ls-1] = this->mq1; | ||||
|       std::vector<Coeff_t> lower(Ls,-1.0);  lower[0]    = this->mq1; | ||||
|  | ||||
|       // no shift term | ||||
|       if(this->shift == 0.0){ this->M5Ddag(psi, chi, chi, lower, diag, upper); } | ||||
|   | ||||
| @@ -111,7 +111,7 @@ namespace QCD { | ||||
|   }; | ||||
| }} | ||||
|  | ||||
| #define INSTANTIATE_DPERP_DWF_EOFA(A)\ | ||||
| #define INSTANTIATE_DPERP_MOBIUS_EOFA(A)\ | ||||
| template void MobiusEOFAFermion<A>::M5D(const FermionField& psi, const FermionField& phi, FermionField& chi, \ | ||||
|   std::vector<Coeff_t>& lower, std::vector<Coeff_t>& diag, std::vector<Coeff_t>& upper); \ | ||||
| template void MobiusEOFAFermion<A>::M5D_shift(const FermionField& psi, const FermionField& phi, FermionField& chi, \ | ||||
| @@ -122,7 +122,7 @@ template void MobiusEOFAFermion<A>::M5Ddag_shift(const FermionField& psi, const | ||||
|   std::vector<Coeff_t>& lower, std::vector<Coeff_t>& diag, std::vector<Coeff_t>& upper, std::vector<Coeff_t>& shift_coeffs); \ | ||||
| template void MobiusEOFAFermion<A>::MooeeInv(const FermionField& psi, FermionField& chi); \ | ||||
| template void MobiusEOFAFermion<A>::MooeeInv_shift(const FermionField& psi, FermionField& chi); \ | ||||
| template void MobiusEOFAFermion<A>::MooeeInvDag(const FermionField& psi, FermionField& chi); | ||||
| template void MobiusEOFAFermion<A>::MooeeInvDag(const FermionField& psi, FermionField& chi); \ | ||||
| template void MobiusEOFAFermion<A>::MooeeInvDag_shift(const FermionField& psi, FermionField& chi); | ||||
|  | ||||
| #undef  MOBIUS_EOFA_DPERP_DENSE | ||||
|   | ||||
							
								
								
									
										184
									
								
								lib/qcd/action/fermion/MobiusEOFAFermiondense.cc
									
									
									
									
									
										Normal file
									
								
							
							
						
						
									
										184
									
								
								lib/qcd/action/fermion/MobiusEOFAFermiondense.cc
									
									
									
									
									
										Normal file
									
								
							| @@ -0,0 +1,184 @@ | ||||
| /************************************************************************************* | ||||
|  | ||||
| Grid physics library, www.github.com/paboyle/Grid | ||||
|  | ||||
| Source file: ./lib/qcd/action/fermion/MobiusEOFAFermiondense.cc | ||||
|  | ||||
| Copyright (C) 2017 | ||||
|  | ||||
| Author: Peter Boyle <pabobyle@ph.ed.ac.uk> | ||||
| 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: David Murphy <dmurphy@phys.columbia.edu> | ||||
|  | ||||
| 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_Eigen_Dense.h> | ||||
| #include <Grid/qcd/action/fermion/FermionCore.h> | ||||
| #include <Grid/qcd/action/fermion/MobiusEOFAFermion.h> | ||||
|  | ||||
| namespace Grid { | ||||
| namespace QCD { | ||||
|  | ||||
|   /* | ||||
|   * Dense matrix versions of routines | ||||
|   */ | ||||
|   template<class Impl> | ||||
|   void MobiusEOFAFermion<Impl>::MooeeInv(const FermionField& psi, FermionField& chi) | ||||
|   { | ||||
|     this->MooeeInternal(psi, chi, DaggerNo, InverseYes); | ||||
|   } | ||||
|  | ||||
|   template<class Impl> | ||||
|   void MobiusEOFAFermion<Impl>::MooeeInv_shift(const FermionField& psi, FermionField& chi) | ||||
|   { | ||||
|     this->MooeeInternal(psi, chi, DaggerNo, InverseYes); | ||||
|   } | ||||
|  | ||||
|   template<class Impl> | ||||
|   void MobiusEOFAFermion<Impl>::MooeeInvDag(const FermionField& psi, FermionField& chi) | ||||
|   { | ||||
|     this->MooeeInternal(psi, chi, DaggerYes, InverseYes); | ||||
|   } | ||||
|  | ||||
|   template<class Impl> | ||||
|   void MobiusEOFAFermion<Impl>::MooeeInvDag_shift(const FermionField& psi, FermionField& chi) | ||||
|   { | ||||
|     this->MooeeInternal(psi, chi, DaggerYes, InverseYes); | ||||
|   } | ||||
|  | ||||
|   template<class Impl> | ||||
|   void MobiusEOFAFermion<Impl>::MooeeInternal(const FermionField& psi, FermionField& chi, int dag, int inv) | ||||
|   { | ||||
|     int Ls = this->Ls; | ||||
|     int LLs = psi._grid->_rdimensions[0]; | ||||
|     int vol = psi._grid->oSites()/LLs; | ||||
|  | ||||
|     int pm      = this->pm; | ||||
|     RealD shift = this->shift; | ||||
|     RealD alpha = this->alpha; | ||||
|     RealD k     = this->k; | ||||
|     RealD mq1   = this->mq1; | ||||
|  | ||||
|     chi.checkerboard = psi.checkerboard; | ||||
|  | ||||
|     assert(Ls==LLs); | ||||
|  | ||||
|     Eigen::MatrixXd Pplus  = Eigen::MatrixXd::Zero(Ls,Ls); | ||||
|     Eigen::MatrixXd Pminus = Eigen::MatrixXd::Zero(Ls,Ls); | ||||
|  | ||||
|     for(int s=0;s<Ls;s++){ | ||||
|         Pplus(s,s)  = this->bee[s]; | ||||
|         Pminus(s,s) = this->bee[s]; | ||||
|     } | ||||
|  | ||||
|     for(int s=0; s<Ls-1; s++){ | ||||
|         Pminus(s,s+1) = -this->cee[s]; | ||||
|     } | ||||
|  | ||||
|     for(int s=0; s<Ls-1; s++){ | ||||
|         Pplus(s+1,s) = -this->cee[s+1]; | ||||
|     } | ||||
|     Pplus (0,Ls-1) = mq1*this->cee[0]; | ||||
|     Pminus(Ls-1,0) = mq1*this->cee[Ls-1]; | ||||
|  | ||||
|     if(shift != 0.0){ | ||||
|       Coeff_t N = 2.0 * ( std::pow(alpha+1.0,Ls) + mq1*std::pow(alpha-1.0,Ls) ); | ||||
|       for(int s=0; s<Ls; ++s){ | ||||
|         if(pm == 1){ Pplus(s,Ls-1) += shift * k * N * std::pow(-1.0,s) * std::pow(alpha-1.0,s) / std::pow(alpha+1.0,Ls+s+1); } | ||||
|         else{ Pminus(Ls-1-s,Ls-1) -= shift * k * N * std::pow(-1.0,s) * std::pow(alpha-1.0,s) / std::pow(alpha+1.0,Ls+s+1); } | ||||
|       } | ||||
|     } | ||||
|  | ||||
|     Eigen::MatrixXd PplusMat ; | ||||
|     Eigen::MatrixXd PminusMat; | ||||
|  | ||||
|     if(inv){ | ||||
|       PplusMat  = Pplus.inverse(); | ||||
|       PminusMat = Pminus.inverse(); | ||||
|     } else { | ||||
|       PplusMat  = Pplus; | ||||
|       PminusMat = Pminus; | ||||
|     } | ||||
|  | ||||
|     if(dag){ | ||||
|       PplusMat.adjointInPlace(); | ||||
|       PminusMat.adjointInPlace(); | ||||
|     } | ||||
|  | ||||
|     // For the non-vectorised s-direction this is simple | ||||
|  | ||||
|     for(auto site=0; site<vol; site++){ | ||||
|  | ||||
|         SiteSpinor     SiteChi; | ||||
|         SiteHalfSpinor SitePplus; | ||||
|         SiteHalfSpinor SitePminus; | ||||
|  | ||||
|         for(int s1=0; s1<Ls; s1++){ | ||||
|             SiteChi = zero; | ||||
|             for(int s2=0; s2<Ls; s2++){ | ||||
|                 int lex2 = s2 + Ls*site; | ||||
|                 if(PplusMat(s1,s2) != 0.0){ | ||||
|                     spProj5p(SitePplus,psi[lex2]); | ||||
|                     accumRecon5p(SiteChi, PplusMat(s1,s2)*SitePplus); | ||||
|                 } | ||||
|                 if(PminusMat(s1,s2) != 0.0){ | ||||
|                     spProj5m(SitePminus, psi[lex2]); | ||||
|                     accumRecon5m(SiteChi, PminusMat(s1,s2)*SitePminus); | ||||
|                 } | ||||
|             } | ||||
|             chi[s1+Ls*site] = SiteChi*0.5; | ||||
|         } | ||||
|     } | ||||
|   } | ||||
|  | ||||
|   #ifdef MOBIUS_EOFA_DPERP_DENSE | ||||
|  | ||||
|     INSTANTIATE_DPERP_MOBIUS_EOFA(GparityWilsonImplF); | ||||
|     INSTANTIATE_DPERP_MOBIUS_EOFA(GparityWilsonImplD); | ||||
|     INSTANTIATE_DPERP_MOBIUS_EOFA(WilsonImplF); | ||||
|     INSTANTIATE_DPERP_MOBIUS_EOFA(WilsonImplD); | ||||
|     INSTANTIATE_DPERP_MOBIUS_EOFA(ZWilsonImplF); | ||||
|     INSTANTIATE_DPERP_MOBIUS_EOFA(ZWilsonImplD); | ||||
|  | ||||
|     template void MobiusEOFAFermion<GparityWilsonImplF>::MooeeInternal(const FermionField& psi, FermionField& chi, int dag, int inv); | ||||
|     template void MobiusEOFAFermion<GparityWilsonImplD>::MooeeInternal(const FermionField& psi, FermionField& chi, int dag, int inv); | ||||
|     template void MobiusEOFAFermion<WilsonImplF>::MooeeInternal(const FermionField& psi, FermionField& chi, int dag, int inv); | ||||
|     template void MobiusEOFAFermion<WilsonImplD>::MooeeInternal(const FermionField& psi, FermionField& chi, int dag, int inv); | ||||
|     template void MobiusEOFAFermion<ZWilsonImplF>::MooeeInternal(const FermionField& psi, FermionField& chi, int dag, int inv); | ||||
|     template void MobiusEOFAFermion<ZWilsonImplD>::MooeeInternal(const FermionField& psi, FermionField& chi, int dag, int inv); | ||||
|  | ||||
|     INSTANTIATE_DPERP_MOBIUS_EOFA(GparityWilsonImplFH); | ||||
|     INSTANTIATE_DPERP_MOBIUS_EOFA(GparityWilsonImplDF); | ||||
|     INSTANTIATE_DPERP_MOBIUS_EOFA(WilsonImplFH); | ||||
|     INSTANTIATE_DPERP_MOBIUS_EOFA(WilsonImplDF); | ||||
|     INSTANTIATE_DPERP_MOBIUS_EOFA(ZWilsonImplFH); | ||||
|     INSTANTIATE_DPERP_MOBIUS_EOFA(ZWilsonImplDF); | ||||
|  | ||||
|     template void MobiusEOFAFermion<GparityWilsonImplFH>::MooeeInternal(const FermionField& psi, FermionField& chi, int dag, int inv); | ||||
|     template void MobiusEOFAFermion<GparityWilsonImplDF>::MooeeInternal(const FermionField& psi, FermionField& chi, int dag, int inv); | ||||
|     template void MobiusEOFAFermion<WilsonImplFH>::MooeeInternal(const FermionField& psi, FermionField& chi, int dag, int inv); | ||||
|     template void MobiusEOFAFermion<WilsonImplDF>::MooeeInternal(const FermionField& psi, FermionField& chi, int dag, int inv); | ||||
|     template void MobiusEOFAFermion<ZWilsonImplFH>::MooeeInternal(const FermionField& psi, FermionField& chi, int dag, int inv); | ||||
|     template void MobiusEOFAFermion<ZWilsonImplDF>::MooeeInternal(const FermionField& psi, FermionField& chi, int dag, int inv); | ||||
|  | ||||
|   #endif | ||||
|  | ||||
| }} | ||||
							
								
								
									
										290
									
								
								lib/qcd/action/fermion/MobiusEOFAFermionssp.cc
									
									
									
									
									
										Normal file
									
								
							
							
						
						
									
										290
									
								
								lib/qcd/action/fermion/MobiusEOFAFermionssp.cc
									
									
									
									
									
										Normal file
									
								
							| @@ -0,0 +1,290 @@ | ||||
| /************************************************************************************* | ||||
|  | ||||
| Grid physics library, www.github.com/paboyle/Grid | ||||
|  | ||||
| Source file: ./lib/qcd/action/fermion/MobiusEOFAFermionssp.cc | ||||
|  | ||||
| Copyright (C) 2017 | ||||
|  | ||||
| Author: Peter Boyle <pabobyle@ph.ed.ac.uk> | ||||
| 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: David Murphy <dmurphy@phys.columbia.edu> | ||||
|  | ||||
| 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/MobiusEOFAFermion.h> | ||||
|  | ||||
| namespace Grid { | ||||
| namespace QCD { | ||||
|  | ||||
|   // FIXME -- make a version of these routines with site loop outermost for cache reuse. | ||||
|   // Pminus fowards | ||||
|   // Pplus  backwards | ||||
|   template<class Impl> | ||||
|   void MobiusEOFAFermion<Impl>::M5D(const FermionField& psi, const FermionField& phi, | ||||
|     FermionField& chi, std::vector<Coeff_t>& lower, std::vector<Coeff_t>& diag, std::vector<Coeff_t>& upper) | ||||
|   { | ||||
|     Coeff_t one(1.0); | ||||
|     int Ls = this->Ls; | ||||
|     for(int s=0; s<Ls; s++){ | ||||
|       if(s==0) { | ||||
|         axpby_ssp_pminus(chi, diag[s], phi, upper[s], psi, s, s+1); | ||||
|         axpby_ssp_pplus (chi, one, chi, lower[s], psi, s, Ls-1); | ||||
|       } else if (s==(Ls-1)) { | ||||
|         axpby_ssp_pminus(chi, diag[s], phi, upper[s], psi, s, 0); | ||||
|         axpby_ssp_pplus (chi, one, chi, lower[s], psi, s, s-1); | ||||
|       } else { | ||||
|         axpby_ssp_pminus(chi, diag[s], phi, upper[s], psi, s, s+1); | ||||
|         axpby_ssp_pplus(chi, one, chi, lower[s], psi, s, s-1); | ||||
|       } | ||||
|     } | ||||
|   } | ||||
|  | ||||
|   template<class Impl> | ||||
|   void MobiusEOFAFermion<Impl>::M5D_shift(const FermionField& psi, const FermionField& phi, | ||||
|     FermionField& chi, std::vector<Coeff_t>& lower, std::vector<Coeff_t>& diag, std::vector<Coeff_t>& upper, | ||||
|     std::vector<Coeff_t>& shift_coeffs) | ||||
|   { | ||||
|     Coeff_t one(1.0); | ||||
|     int Ls = this->Ls; | ||||
|     for(int s=0; s<Ls; s++){ | ||||
|       if(s==0) { | ||||
|         axpby_ssp_pminus(chi, diag[s], phi, upper[s], psi, s, s+1); | ||||
|         axpby_ssp_pplus (chi, one, chi, lower[s], psi, s, Ls-1); | ||||
|       } else if (s==(Ls-1)) { | ||||
|         axpby_ssp_pminus(chi, diag[s], phi, upper[s], psi, s, 0); | ||||
|         axpby_ssp_pplus (chi, one, chi, lower[s], psi, s, s-1); | ||||
|       } else { | ||||
|         axpby_ssp_pminus(chi, diag[s], phi, upper[s], psi, s, s+1); | ||||
|         axpby_ssp_pplus(chi, one, chi, lower[s], psi, s, s-1); | ||||
|       } | ||||
|       if(this->pm == 1){ axpby_ssp_pplus(chi, one, chi, shift_coeffs[s], psi, s, Ls-1); } | ||||
|       else{ axpby_ssp_pminus(chi, one, chi, shift_coeffs[s], psi, s, 0); } | ||||
|     } | ||||
|   } | ||||
|  | ||||
|   template<class Impl> | ||||
|   void MobiusEOFAFermion<Impl>::M5Ddag(const FermionField& psi, const FermionField& phi, | ||||
|     FermionField& chi, std::vector<Coeff_t>& lower, std::vector<Coeff_t>& diag, std::vector<Coeff_t>& upper) | ||||
|   { | ||||
|     Coeff_t one(1.0); | ||||
|     int Ls = this->Ls; | ||||
|     for(int s=0; s<Ls; s++){ | ||||
|       if(s==0) { | ||||
|         axpby_ssp_pplus (chi, diag[s], phi, upper[s], psi, s, s+1); | ||||
|         axpby_ssp_pminus(chi, one, chi, lower[s], psi, s, Ls-1); | ||||
|       } else if (s==(Ls-1)) { | ||||
|         axpby_ssp_pplus (chi, diag[s], phi, upper[s], psi, s, 0); | ||||
|         axpby_ssp_pminus(chi, one, chi, lower[s], psi, s, s-1); | ||||
|       } else { | ||||
|         axpby_ssp_pplus (chi, diag[s], phi, upper[s], psi, s, s+1); | ||||
|         axpby_ssp_pminus(chi, one, chi, lower[s], psi, s, s-1); | ||||
|       } | ||||
|     } | ||||
|   } | ||||
|  | ||||
|   template<class Impl> | ||||
|   void MobiusEOFAFermion<Impl>::M5Ddag_shift(const FermionField& psi, const FermionField& phi, | ||||
|     FermionField& chi, std::vector<Coeff_t>& lower, std::vector<Coeff_t>& diag, std::vector<Coeff_t>& upper, | ||||
|     std::vector<Coeff_t>& shift_coeffs) | ||||
|   { | ||||
|     Coeff_t one(1.0); | ||||
|     int Ls = this->Ls; | ||||
|     for(int s=0; s<Ls; s++){ | ||||
|       if(s==0) { | ||||
|         axpby_ssp_pplus (chi, diag[s], phi, upper[s], psi, s, s+1); | ||||
|         axpby_ssp_pminus(chi, one, chi, lower[s], psi, s, Ls-1); | ||||
|       } else if (s==(Ls-1)) { | ||||
|         axpby_ssp_pplus (chi, diag[s], phi, upper[s], psi, s, 0); | ||||
|         axpby_ssp_pminus(chi, one, chi, lower[s], psi, s, s-1); | ||||
|       } else { | ||||
|         axpby_ssp_pplus (chi, diag[s], phi, upper[s], psi, s, s+1); | ||||
|         axpby_ssp_pminus(chi, one, chi, lower[s], psi, s, s-1); | ||||
|       } | ||||
|       if(this->pm == 1){ axpby_ssp_pplus(chi, one, chi, shift_coeffs[s], psi, Ls-1, s); } | ||||
|       else{ axpby_ssp_pminus(chi, one, chi, shift_coeffs[s], psi, 0, s); } | ||||
|     } | ||||
|   } | ||||
|  | ||||
|   template<class Impl> | ||||
|   void MobiusEOFAFermion<Impl>::MooeeInv(const FermionField& psi, FermionField& chi) | ||||
|   { | ||||
|     if(this->shift != 0.0){ MooeeInv_shift(psi,chi); return; } | ||||
|  | ||||
|     Coeff_t one(1.0); | ||||
|     Coeff_t czero(0.0); | ||||
|     chi.checkerboard = psi.checkerboard; | ||||
|     int Ls = this->Ls; | ||||
|  | ||||
|     // Apply (L^{\prime})^{-1} | ||||
|     axpby_ssp(chi, one, psi, czero, psi, 0, 0);      // chi[0]=psi[0] | ||||
|     for(int s=1; s<Ls; s++){ | ||||
|       axpby_ssp_pplus(chi, one, psi, -this->lee[s-1], chi, s, s-1);// recursion Psi[s] -lee P_+ chi[s-1] | ||||
|     } | ||||
|  | ||||
|     // L_m^{-1} | ||||
|     for(int s=0; s<Ls-1; s++){ // Chi[ee] = 1 - sum[s<Ls-1] -leem[s]P_- chi | ||||
|       axpby_ssp_pminus(chi, one, chi, -this->leem[s], chi, Ls-1, s); | ||||
|     } | ||||
|  | ||||
|     // U_m^{-1} D^{-1} | ||||
|     for(int s=0; s<Ls-1; s++){ | ||||
|       axpby_ssp_pplus(chi, one/this->dee[s], chi, -this->ueem[s]/this->dee[Ls-1], chi, s, Ls-1); | ||||
|     } | ||||
|     axpby_ssp(chi, one/this->dee[Ls-1], chi, czero, chi, Ls-1, Ls-1); | ||||
|  | ||||
|     // Apply U^{-1} | ||||
|     for(int s=Ls-2; s>=0; s--){ | ||||
|       axpby_ssp_pminus(chi, one, chi, -this->uee[s], chi, s, s+1);  // chi[Ls] | ||||
|     } | ||||
|   } | ||||
|  | ||||
|   template<class Impl> | ||||
|   void MobiusEOFAFermion<Impl>::MooeeInv_shift(const FermionField& psi, FermionField& chi) | ||||
|   { | ||||
|     Coeff_t one(1.0); | ||||
|     Coeff_t czero(0.0); | ||||
|     chi.checkerboard = psi.checkerboard; | ||||
|     int Ls = this->Ls; | ||||
|  | ||||
|     FermionField tmp(psi._grid); | ||||
|  | ||||
|     // Apply (L^{\prime})^{-1} | ||||
|     axpby_ssp(chi, one, psi, czero, psi, 0, 0);      // chi[0]=psi[0] | ||||
|     axpby_ssp(tmp, czero, tmp, this->MooeeInv_shift_lc[0], psi, 0, 0); | ||||
|     for(int s=1; s<Ls; s++){ | ||||
|       axpby_ssp_pplus(chi, one, psi, -this->lee[s-1], chi, s, s-1);// recursion Psi[s] -lee P_+ chi[s-1] | ||||
|       axpby_ssp(tmp, one, tmp, this->MooeeInv_shift_lc[s], psi, 0, s); | ||||
|     } | ||||
|  | ||||
|     // L_m^{-1} | ||||
|     for(int s=0; s<Ls-1; s++){ // Chi[ee] = 1 - sum[s<Ls-1] -leem[s]P_- chi | ||||
|       axpby_ssp_pminus(chi, one, chi, -this->leem[s], chi, Ls-1, s); | ||||
|     } | ||||
|  | ||||
|     // U_m^{-1} D^{-1} | ||||
|     for(int s=0; s<Ls-1; s++){ | ||||
|       axpby_ssp_pplus(chi, one/this->dee[s], chi, -this->ueem[s]/this->dee[Ls-1], chi, s, Ls-1); | ||||
|     } | ||||
|     axpby_ssp(chi, one/this->dee[Ls-1], chi, czero, chi, Ls-1, Ls-1); | ||||
|  | ||||
|     // Apply U^{-1} and add shift term | ||||
|     if(this->pm == 1){ axpby_ssp_pplus(chi, one, chi, this->MooeeInv_shift_norm[Ls-1], tmp, Ls-1, 0); } | ||||
|     else{ axpby_ssp_pminus(chi, one, chi, this->MooeeInv_shift_norm[Ls-1], tmp, Ls-1, 0); } | ||||
|     for(int s=Ls-2; s>=0; s--){ | ||||
|       axpby_ssp_pminus(chi, one, chi, -this->uee[s], chi, s, s+1);  // chi[Ls] | ||||
|       if(this->pm == 1){ axpby_ssp_pplus(chi, one, chi, this->MooeeInv_shift_norm[s], tmp, s, 0); } | ||||
|       else{ axpby_ssp_pminus(chi, one, chi, this->MooeeInv_shift_norm[s], tmp, s, 0); } | ||||
|     } | ||||
|   } | ||||
|  | ||||
|   template<class Impl> | ||||
|   void MobiusEOFAFermion<Impl>::MooeeInvDag(const FermionField& psi, FermionField& chi) | ||||
|   { | ||||
|     if(this->shift != 0.0){ MooeeInvDag_shift(psi,chi); return; } | ||||
|  | ||||
|     Coeff_t one(1.0); | ||||
|     Coeff_t czero(0.0); | ||||
|     chi.checkerboard = psi.checkerboard; | ||||
|     int Ls = this->Ls; | ||||
|  | ||||
|     // Apply (U^{\prime})^{-dagger} | ||||
|     axpby_ssp(chi, one, psi, czero, psi, 0, 0);      // chi[0]=psi[0] | ||||
|     for(int s=1; s<Ls; s++){ | ||||
|       axpby_ssp_pminus(chi, one, psi, -conjugate(this->uee[s-1]), chi, s, s-1); | ||||
|     } | ||||
|  | ||||
|     // U_m^{-\dagger} | ||||
|     for(int s=0; s<Ls-1; s++){ | ||||
|       axpby_ssp_pplus(chi, one, chi, -conjugate(this->ueem[s]), chi, Ls-1, s); | ||||
|     } | ||||
|  | ||||
|     // L_m^{-\dagger} D^{-dagger} | ||||
|     for(int s=0; s<Ls-1; s++){ | ||||
|       axpby_ssp_pminus(chi, one/conjugate(this->dee[s]), chi, -conjugate(this->leem[s]/this->dee[Ls-1]), chi, s, Ls-1); | ||||
|     } | ||||
|     axpby_ssp(chi, one/conjugate(this->dee[Ls-1]), chi, czero, chi, Ls-1, Ls-1); | ||||
|  | ||||
|     // Apply L^{-dagger} | ||||
|     for(int s=Ls-2; s>=0; s--){ | ||||
|       axpby_ssp_pplus(chi, one, chi, -conjugate(this->lee[s]), chi, s, s+1);  // chi[Ls] | ||||
|     } | ||||
|   } | ||||
|  | ||||
|   template<class Impl> | ||||
|   void MobiusEOFAFermion<Impl>::MooeeInvDag_shift(const FermionField& psi, FermionField& chi) | ||||
|   { | ||||
|     Coeff_t one(1.0); | ||||
|     Coeff_t czero(0.0); | ||||
|     chi.checkerboard = psi.checkerboard; | ||||
|     int Ls = this->Ls; | ||||
|  | ||||
|     FermionField tmp(psi._grid); | ||||
|  | ||||
|     // Apply (U^{\prime})^{-dagger} and accumulate (MooeeInvDag_shift_lc)_{j} \psi_{j} in tmp[0] | ||||
|     axpby_ssp(chi, one, psi, czero, psi, 0, 0);      // chi[0]=psi[0] | ||||
|     axpby_ssp(tmp, czero, tmp, this->MooeeInvDag_shift_lc[0], psi, 0, 0); | ||||
|     for(int s=1; s<Ls; s++){ | ||||
|       axpby_ssp_pminus(chi, one, psi, -conjugate(this->uee[s-1]), chi, s, s-1); | ||||
|       axpby_ssp(tmp, one, tmp, this->MooeeInvDag_shift_lc[s], psi, 0, s); | ||||
|     } | ||||
|  | ||||
|     // U_m^{-\dagger} | ||||
|     for(int s=0; s<Ls-1; s++){ | ||||
|       axpby_ssp_pplus(chi, one, chi, -conjugate(this->ueem[s]), chi, Ls-1, s); | ||||
|     } | ||||
|  | ||||
|     // L_m^{-\dagger} D^{-dagger} | ||||
|     for(int s=0; s<Ls-1; s++){ | ||||
|       axpby_ssp_pminus(chi, one/conjugate(this->dee[s]), chi, -conjugate(this->leem[s]/this->dee[Ls-1]), chi, s, Ls-1); | ||||
|     } | ||||
|     axpby_ssp(chi, one/conjugate(this->dee[Ls-1]), chi, czero, chi, Ls-1, Ls-1); | ||||
|  | ||||
|     // Apply L^{-dagger} and add shift | ||||
|     if(this->pm == 1){ axpby_ssp_pplus(chi, one, chi, this->MooeeInvDag_shift_norm[Ls-1], tmp, Ls-1, 0); } | ||||
|     else{ axpby_ssp_pminus(chi, one, chi, this->MooeeInvDag_shift_norm[Ls-1], tmp, Ls-1, 0); } | ||||
|     for(int s=Ls-2; s>=0; s--){ | ||||
|       axpby_ssp_pplus(chi, one, chi, -conjugate(this->lee[s]), chi, s, s+1);  // chi[Ls] | ||||
|       if(this->pm == 1){ axpby_ssp_pplus(chi, one, chi, this->MooeeInvDag_shift_norm[s], tmp, s, 0); } | ||||
|       else{ axpby_ssp_pminus(chi, one, chi, this->MooeeInvDag_shift_norm[s], tmp, s, 0); } | ||||
|     } | ||||
|   } | ||||
|  | ||||
|   #ifdef MOBIUS_EOFA_DPERP_LINALG | ||||
|  | ||||
|     INSTANTIATE_DPERP_MOBIUS_EOFA(WilsonImplF); | ||||
|     INSTANTIATE_DPERP_MOBIUS_EOFA(WilsonImplD); | ||||
|     INSTANTIATE_DPERP_MOBIUS_EOFA(GparityWilsonImplF); | ||||
|     INSTANTIATE_DPERP_MOBIUS_EOFA(GparityWilsonImplD); | ||||
|     INSTANTIATE_DPERP_MOBIUS_EOFA(ZWilsonImplF); | ||||
|     INSTANTIATE_DPERP_MOBIUS_EOFA(ZWilsonImplD); | ||||
|  | ||||
|     INSTANTIATE_DPERP_MOBIUS_EOFA(WilsonImplFH); | ||||
|     INSTANTIATE_DPERP_MOBIUS_EOFA(WilsonImplDF); | ||||
|     INSTANTIATE_DPERP_MOBIUS_EOFA(GparityWilsonImplFH); | ||||
|     INSTANTIATE_DPERP_MOBIUS_EOFA(GparityWilsonImplDF); | ||||
|     INSTANTIATE_DPERP_MOBIUS_EOFA(ZWilsonImplFH); | ||||
|     INSTANTIATE_DPERP_MOBIUS_EOFA(ZWilsonImplDF); | ||||
|  | ||||
|   #endif | ||||
|  | ||||
| }} | ||||
							
								
								
									
										654
									
								
								lib/qcd/action/fermion/MobiusEOFAFermionvec.cc
									
									
									
									
									
										Normal file
									
								
							
							
						
						
									
										654
									
								
								lib/qcd/action/fermion/MobiusEOFAFermionvec.cc
									
									
									
									
									
										Normal file
									
								
							| @@ -0,0 +1,654 @@ | ||||
| /************************************************************************************* | ||||
|  | ||||
| Grid physics library, www.github.com/paboyle/Grid | ||||
|  | ||||
| Source file: ./lib/qcd/action/fermion/MobiusEOFAFermionvec.cc | ||||
|  | ||||
| Copyright (C) 2017 | ||||
|  | ||||
| Author: Peter Boyle <pabobyle@ph.ed.ac.uk> | ||||
| 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: David Murphy <dmurphy@phys.columbia.edu> | ||||
|  | ||||
| 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/MobiusEOFAFermion.h> | ||||
|  | ||||
| namespace Grid { | ||||
| namespace QCD { | ||||
|  | ||||
|   /* | ||||
|   * Dense matrix versions of routines | ||||
|   */ | ||||
|   template<class Impl> | ||||
|   void MobiusEOFAFermion<Impl>::MooeeInv(const FermionField& psi, FermionField& chi) | ||||
|   { | ||||
|     this->MooeeInternal(psi, chi, DaggerNo, InverseYes); | ||||
|   } | ||||
|  | ||||
|   template<class Impl> | ||||
|   void MobiusEOFAFermion<Impl>::MooeeInv_shift(const FermionField& psi, FermionField& chi) | ||||
|   { | ||||
|     this->MooeeInternal(psi, chi, DaggerNo, InverseYes); | ||||
|   } | ||||
|  | ||||
|   template<class Impl> | ||||
|   void MobiusEOFAFermion<Impl>::MooeeInvDag(const FermionField& psi, FermionField& chi) | ||||
|   { | ||||
|     this->MooeeInternal(psi, chi, DaggerYes, InverseYes); | ||||
|   } | ||||
|  | ||||
|   template<class Impl> | ||||
|   void MobiusEOFAFermion<Impl>::MooeeInvDag_shift(const FermionField& psi, FermionField& chi) | ||||
|   { | ||||
|     this->MooeeInternal(psi, chi, DaggerYes, InverseYes); | ||||
|   } | ||||
|  | ||||
|   template<class Impl> | ||||
|   void MobiusEOFAFermion<Impl>::M5D(const FermionField& psi, const FermionField& phi, | ||||
|     FermionField& chi, std::vector<Coeff_t>& lower, std::vector<Coeff_t>& diag, std::vector<Coeff_t>& upper) | ||||
|   { | ||||
|     GridBase* grid  = psi._grid; | ||||
|     int Ls          = this->Ls; | ||||
|     int LLs         = grid->_rdimensions[0]; | ||||
|     const int nsimd = Simd::Nsimd(); | ||||
|  | ||||
|     Vector<iSinglet<Simd>> u(LLs); | ||||
|     Vector<iSinglet<Simd>> l(LLs); | ||||
|     Vector<iSinglet<Simd>> d(LLs); | ||||
|  | ||||
|     assert(Ls/LLs == nsimd); | ||||
|     assert(phi.checkerboard == psi.checkerboard); | ||||
|  | ||||
|     chi.checkerboard = psi.checkerboard; | ||||
|  | ||||
|     // just directly address via type pun | ||||
|     typedef typename Simd::scalar_type scalar_type; | ||||
|     scalar_type* u_p = (scalar_type*) &u[0]; | ||||
|     scalar_type* l_p = (scalar_type*) &l[0]; | ||||
|     scalar_type* d_p = (scalar_type*) &d[0]; | ||||
|  | ||||
|     for(int o=0; o<LLs; o++){ // outer | ||||
|     for(int i=0; i<nsimd; i++){ //inner | ||||
|       int s   = o + i*LLs; | ||||
|       int ss  = o*nsimd + i; | ||||
|       u_p[ss] = upper[s]; | ||||
|       l_p[ss] = lower[s]; | ||||
|       d_p[ss] = diag[s]; | ||||
|     }} | ||||
|  | ||||
|     this->M5Dcalls++; | ||||
|     this->M5Dtime -= usecond(); | ||||
|  | ||||
|     assert(Nc == 3); | ||||
|  | ||||
|     parallel_for(int ss=0; ss<grid->oSites(); ss+=LLs){ // adds LLs | ||||
|  | ||||
|       #if 0 | ||||
|  | ||||
|         alignas(64) SiteHalfSpinor hp; | ||||
|         alignas(64) SiteHalfSpinor hm; | ||||
|         alignas(64) SiteSpinor fp; | ||||
|         alignas(64) SiteSpinor fm; | ||||
|  | ||||
|         for(int v=0; v<LLs; v++){ | ||||
|  | ||||
|           int vp = (v+1)%LLs; | ||||
|           int vm = (v+LLs-1)%LLs; | ||||
|  | ||||
|           spProj5m(hp, psi[ss+vp]); | ||||
|           spProj5p(hm, psi[ss+vm]); | ||||
|  | ||||
|           if (vp <= v){ rotate(hp, hp, 1); } | ||||
|           if (vm >= v){ rotate(hm, hm, nsimd-1); } | ||||
|  | ||||
|           hp = 0.5*hp; | ||||
|           hm = 0.5*hm; | ||||
|  | ||||
|           spRecon5m(fp, hp); | ||||
|           spRecon5p(fm, hm); | ||||
|  | ||||
|           chi[ss+v] = d[v]*phi[ss+v]; | ||||
|           chi[ss+v] = chi[ss+v] + u[v]*fp; | ||||
|           chi[ss+v] = chi[ss+v] + l[v]*fm; | ||||
|  | ||||
|         } | ||||
|  | ||||
|       #else | ||||
|  | ||||
|         for(int v=0; v<LLs; v++){ | ||||
|  | ||||
|           vprefetch(psi[ss+v+LLs]); | ||||
|  | ||||
|           int vp = (v == LLs-1) ? 0     : v+1; | ||||
|           int vm = (v == 0)     ? LLs-1 : v-1; | ||||
|  | ||||
|           Simd hp_00 = psi[ss+vp]()(2)(0); | ||||
|           Simd hp_01 = psi[ss+vp]()(2)(1); | ||||
|           Simd hp_02 = psi[ss+vp]()(2)(2); | ||||
|           Simd hp_10 = psi[ss+vp]()(3)(0); | ||||
|           Simd hp_11 = psi[ss+vp]()(3)(1); | ||||
|           Simd hp_12 = psi[ss+vp]()(3)(2); | ||||
|  | ||||
|           Simd hm_00 = psi[ss+vm]()(0)(0); | ||||
|           Simd hm_01 = psi[ss+vm]()(0)(1); | ||||
|           Simd hm_02 = psi[ss+vm]()(0)(2); | ||||
|           Simd hm_10 = psi[ss+vm]()(1)(0); | ||||
|           Simd hm_11 = psi[ss+vm]()(1)(1); | ||||
|           Simd hm_12 = psi[ss+vm]()(1)(2); | ||||
|  | ||||
|           if(vp <= v){ | ||||
|             hp_00.v = Optimization::Rotate::tRotate<2>(hp_00.v); | ||||
|             hp_01.v = Optimization::Rotate::tRotate<2>(hp_01.v); | ||||
|             hp_02.v = Optimization::Rotate::tRotate<2>(hp_02.v); | ||||
|             hp_10.v = Optimization::Rotate::tRotate<2>(hp_10.v); | ||||
|             hp_11.v = Optimization::Rotate::tRotate<2>(hp_11.v); | ||||
|             hp_12.v = Optimization::Rotate::tRotate<2>(hp_12.v); | ||||
|           } | ||||
|  | ||||
|           if(vm >= v){ | ||||
|             hm_00.v = Optimization::Rotate::tRotate<2*Simd::Nsimd()-2>(hm_00.v); | ||||
|             hm_01.v = Optimization::Rotate::tRotate<2*Simd::Nsimd()-2>(hm_01.v); | ||||
|             hm_02.v = Optimization::Rotate::tRotate<2*Simd::Nsimd()-2>(hm_02.v); | ||||
|             hm_10.v = Optimization::Rotate::tRotate<2*Simd::Nsimd()-2>(hm_10.v); | ||||
|             hm_11.v = Optimization::Rotate::tRotate<2*Simd::Nsimd()-2>(hm_11.v); | ||||
|             hm_12.v = Optimization::Rotate::tRotate<2*Simd::Nsimd()-2>(hm_12.v); | ||||
|           } | ||||
|  | ||||
|           // Can force these to real arithmetic and save 2x. | ||||
|           Simd p_00 = switcheroo<Coeff_t>::mult(d[v]()()(), phi[ss+v]()(0)(0)) + switcheroo<Coeff_t>::mult(l[v]()()(), hm_00); | ||||
|           Simd p_01 = switcheroo<Coeff_t>::mult(d[v]()()(), phi[ss+v]()(0)(1)) + switcheroo<Coeff_t>::mult(l[v]()()(), hm_01); | ||||
|           Simd p_02 = switcheroo<Coeff_t>::mult(d[v]()()(), phi[ss+v]()(0)(2)) + switcheroo<Coeff_t>::mult(l[v]()()(), hm_02); | ||||
|           Simd p_10 = switcheroo<Coeff_t>::mult(d[v]()()(), phi[ss+v]()(1)(0)) + switcheroo<Coeff_t>::mult(l[v]()()(), hm_10); | ||||
|           Simd p_11 = switcheroo<Coeff_t>::mult(d[v]()()(), phi[ss+v]()(1)(1)) + switcheroo<Coeff_t>::mult(l[v]()()(), hm_11); | ||||
|           Simd p_12 = switcheroo<Coeff_t>::mult(d[v]()()(), phi[ss+v]()(1)(2)) + switcheroo<Coeff_t>::mult(l[v]()()(), hm_12); | ||||
|           Simd p_20 = switcheroo<Coeff_t>::mult(d[v]()()(), phi[ss+v]()(2)(0)) + switcheroo<Coeff_t>::mult(u[v]()()(), hp_00); | ||||
|           Simd p_21 = switcheroo<Coeff_t>::mult(d[v]()()(), phi[ss+v]()(2)(1)) + switcheroo<Coeff_t>::mult(u[v]()()(), hp_01); | ||||
|           Simd p_22 = switcheroo<Coeff_t>::mult(d[v]()()(), phi[ss+v]()(2)(2)) + switcheroo<Coeff_t>::mult(u[v]()()(), hp_02); | ||||
|           Simd p_30 = switcheroo<Coeff_t>::mult(d[v]()()(), phi[ss+v]()(3)(0)) + switcheroo<Coeff_t>::mult(u[v]()()(), hp_10); | ||||
|           Simd p_31 = switcheroo<Coeff_t>::mult(d[v]()()(), phi[ss+v]()(3)(1)) + switcheroo<Coeff_t>::mult(u[v]()()(), hp_11); | ||||
|           Simd p_32 = switcheroo<Coeff_t>::mult(d[v]()()(), phi[ss+v]()(3)(2)) + switcheroo<Coeff_t>::mult(u[v]()()(), hp_12); | ||||
|  | ||||
|           vstream(chi[ss+v]()(0)(0), p_00); | ||||
|           vstream(chi[ss+v]()(0)(1), p_01); | ||||
|           vstream(chi[ss+v]()(0)(2), p_02); | ||||
|           vstream(chi[ss+v]()(1)(0), p_10); | ||||
|           vstream(chi[ss+v]()(1)(1), p_11); | ||||
|           vstream(chi[ss+v]()(1)(2), p_12); | ||||
|           vstream(chi[ss+v]()(2)(0), p_20); | ||||
|           vstream(chi[ss+v]()(2)(1), p_21); | ||||
|           vstream(chi[ss+v]()(2)(2), p_22); | ||||
|           vstream(chi[ss+v]()(3)(0), p_30); | ||||
|           vstream(chi[ss+v]()(3)(1), p_31); | ||||
|           vstream(chi[ss+v]()(3)(2), p_32); | ||||
|         } | ||||
|  | ||||
|       #endif | ||||
|     } | ||||
|  | ||||
|     this->M5Dtime += usecond(); | ||||
|   } | ||||
|  | ||||
|   template<class Impl> | ||||
|   void MobiusEOFAFermion<Impl>::M5D_shift(const FermionField& psi, const FermionField& phi, | ||||
|     FermionField& chi, std::vector<Coeff_t>& lower, std::vector<Coeff_t>& diag, std::vector<Coeff_t>& upper, | ||||
|     std::vector<Coeff_t>& shift_coeffs) | ||||
|   { | ||||
|     this->M5D(psi, phi, chi, lower, diag, upper); | ||||
|  | ||||
|     // FIXME: possible gain from vectorizing shift operation as well? | ||||
|     Coeff_t one(1.0); | ||||
|     int Ls = this->Ls; | ||||
|     for(int s=0; s<Ls; s++){ | ||||
|       if(this->pm == 1){ axpby_ssp_pplus(chi, one, chi, shift_coeffs[s], psi, s, Ls-1); } | ||||
|       else{ axpby_ssp_pminus(chi, one, chi, shift_coeffs[s], psi, s, 0); } | ||||
|     } | ||||
|   } | ||||
|  | ||||
|   template<class Impl> | ||||
|   void MobiusEOFAFermion<Impl>::M5Ddag(const FermionField& psi, const FermionField& phi, | ||||
|     FermionField& chi, std::vector<Coeff_t>& lower, std::vector<Coeff_t>& diag, std::vector<Coeff_t>& upper) | ||||
|   { | ||||
|     GridBase* grid = psi._grid; | ||||
|     int Ls  = this->Ls; | ||||
|     int LLs = grid->_rdimensions[0]; | ||||
|     int nsimd = Simd::Nsimd(); | ||||
|  | ||||
|     Vector<iSinglet<Simd> > u(LLs); | ||||
|     Vector<iSinglet<Simd> > l(LLs); | ||||
|     Vector<iSinglet<Simd> > d(LLs); | ||||
|  | ||||
|     assert(Ls/LLs == nsimd); | ||||
|     assert(phi.checkerboard == psi.checkerboard); | ||||
|  | ||||
|     chi.checkerboard = psi.checkerboard; | ||||
|  | ||||
|     // just directly address via type pun | ||||
|     typedef typename Simd::scalar_type scalar_type; | ||||
|     scalar_type* u_p = (scalar_type*) &u[0]; | ||||
|     scalar_type* l_p = (scalar_type*) &l[0]; | ||||
|     scalar_type* d_p = (scalar_type*) &d[0]; | ||||
|  | ||||
|     for(int o=0; o<LLs; o++){ // outer | ||||
|     for(int i=0; i<nsimd; i++){ //inner | ||||
|       int s  = o + i*LLs; | ||||
|       int ss = o*nsimd + i; | ||||
|       u_p[ss] = upper[s]; | ||||
|       l_p[ss] = lower[s]; | ||||
|       d_p[ss] = diag[s]; | ||||
|     }} | ||||
|  | ||||
|     this->M5Dcalls++; | ||||
|     this->M5Dtime -= usecond(); | ||||
|  | ||||
|     parallel_for(int ss=0; ss<grid->oSites(); ss+=LLs){ // adds LLs | ||||
|  | ||||
|       #if 0 | ||||
|  | ||||
|         alignas(64) SiteHalfSpinor hp; | ||||
|         alignas(64) SiteHalfSpinor hm; | ||||
|         alignas(64) SiteSpinor fp; | ||||
|         alignas(64) SiteSpinor fm; | ||||
|  | ||||
|         for(int v=0; v<LLs; v++){ | ||||
|  | ||||
|           int vp = (v+1)%LLs; | ||||
|           int vm = (v+LLs-1)%LLs; | ||||
|  | ||||
|           spProj5p(hp, psi[ss+vp]); | ||||
|           spProj5m(hm, psi[ss+vm]); | ||||
|  | ||||
|           if(vp <= v){ rotate(hp, hp, 1); } | ||||
|           if(vm >= v){ rotate(hm, hm, nsimd-1); } | ||||
|  | ||||
|           hp = hp*0.5; | ||||
|           hm = hm*0.5; | ||||
|           spRecon5p(fp, hp); | ||||
|           spRecon5m(fm, hm); | ||||
|  | ||||
|           chi[ss+v] = d[v]*phi[ss+v]+u[v]*fp; | ||||
|           chi[ss+v] = chi[ss+v]     +l[v]*fm; | ||||
|  | ||||
|         } | ||||
|  | ||||
|       #else | ||||
|  | ||||
|         for(int v=0; v<LLs; v++){ | ||||
|  | ||||
|           vprefetch(psi[ss+v+LLs]); | ||||
|  | ||||
|           int vp = (v == LLs-1) ? 0     : v+1; | ||||
|           int vm = (v == 0    ) ? LLs-1 : v-1; | ||||
|  | ||||
|           Simd hp_00 = psi[ss+vp]()(0)(0); | ||||
|           Simd hp_01 = psi[ss+vp]()(0)(1); | ||||
|           Simd hp_02 = psi[ss+vp]()(0)(2); | ||||
|           Simd hp_10 = psi[ss+vp]()(1)(0); | ||||
|           Simd hp_11 = psi[ss+vp]()(1)(1); | ||||
|           Simd hp_12 = psi[ss+vp]()(1)(2); | ||||
|  | ||||
|           Simd hm_00 = psi[ss+vm]()(2)(0); | ||||
|           Simd hm_01 = psi[ss+vm]()(2)(1); | ||||
|           Simd hm_02 = psi[ss+vm]()(2)(2); | ||||
|           Simd hm_10 = psi[ss+vm]()(3)(0); | ||||
|           Simd hm_11 = psi[ss+vm]()(3)(1); | ||||
|           Simd hm_12 = psi[ss+vm]()(3)(2); | ||||
|  | ||||
|           if (vp <= v){ | ||||
|             hp_00.v = Optimization::Rotate::tRotate<2>(hp_00.v); | ||||
|             hp_01.v = Optimization::Rotate::tRotate<2>(hp_01.v); | ||||
|             hp_02.v = Optimization::Rotate::tRotate<2>(hp_02.v); | ||||
|             hp_10.v = Optimization::Rotate::tRotate<2>(hp_10.v); | ||||
|             hp_11.v = Optimization::Rotate::tRotate<2>(hp_11.v); | ||||
|             hp_12.v = Optimization::Rotate::tRotate<2>(hp_12.v); | ||||
|           } | ||||
|  | ||||
|           if(vm >= v){ | ||||
|             hm_00.v = Optimization::Rotate::tRotate<2*Simd::Nsimd()-2>(hm_00.v); | ||||
|             hm_01.v = Optimization::Rotate::tRotate<2*Simd::Nsimd()-2>(hm_01.v); | ||||
|             hm_02.v = Optimization::Rotate::tRotate<2*Simd::Nsimd()-2>(hm_02.v); | ||||
|             hm_10.v = Optimization::Rotate::tRotate<2*Simd::Nsimd()-2>(hm_10.v); | ||||
|             hm_11.v = Optimization::Rotate::tRotate<2*Simd::Nsimd()-2>(hm_11.v); | ||||
|             hm_12.v = Optimization::Rotate::tRotate<2*Simd::Nsimd()-2>(hm_12.v); | ||||
|           } | ||||
|  | ||||
|           Simd p_00 = switcheroo<Coeff_t>::mult(d[v]()()(), phi[ss+v]()(0)(0)) + switcheroo<Coeff_t>::mult(u[v]()()(), hp_00); | ||||
|           Simd p_01 = switcheroo<Coeff_t>::mult(d[v]()()(), phi[ss+v]()(0)(1)) + switcheroo<Coeff_t>::mult(u[v]()()(), hp_01); | ||||
|           Simd p_02 = switcheroo<Coeff_t>::mult(d[v]()()(), phi[ss+v]()(0)(2)) + switcheroo<Coeff_t>::mult(u[v]()()(), hp_02); | ||||
|           Simd p_10 = switcheroo<Coeff_t>::mult(d[v]()()(), phi[ss+v]()(1)(0)) + switcheroo<Coeff_t>::mult(u[v]()()(), hp_10); | ||||
|           Simd p_11 = switcheroo<Coeff_t>::mult(d[v]()()(), phi[ss+v]()(1)(1)) + switcheroo<Coeff_t>::mult(u[v]()()(), hp_11); | ||||
|           Simd p_12 = switcheroo<Coeff_t>::mult(d[v]()()(), phi[ss+v]()(1)(2)) + switcheroo<Coeff_t>::mult(u[v]()()(), hp_12); | ||||
|           Simd p_20 = switcheroo<Coeff_t>::mult(d[v]()()(), phi[ss+v]()(2)(0)) + switcheroo<Coeff_t>::mult(l[v]()()(), hm_00); | ||||
|           Simd p_21 = switcheroo<Coeff_t>::mult(d[v]()()(), phi[ss+v]()(2)(1)) + switcheroo<Coeff_t>::mult(l[v]()()(), hm_01); | ||||
|           Simd p_22 = switcheroo<Coeff_t>::mult(d[v]()()(), phi[ss+v]()(2)(2)) + switcheroo<Coeff_t>::mult(l[v]()()(), hm_02); | ||||
|           Simd p_30 = switcheroo<Coeff_t>::mult(d[v]()()(), phi[ss+v]()(3)(0)) + switcheroo<Coeff_t>::mult(l[v]()()(), hm_10); | ||||
|           Simd p_31 = switcheroo<Coeff_t>::mult(d[v]()()(), phi[ss+v]()(3)(1)) + switcheroo<Coeff_t>::mult(l[v]()()(), hm_11); | ||||
|           Simd p_32 = switcheroo<Coeff_t>::mult(d[v]()()(), phi[ss+v]()(3)(2)) + switcheroo<Coeff_t>::mult(l[v]()()(), hm_12); | ||||
|  | ||||
|           vstream(chi[ss+v]()(0)(0), p_00); | ||||
|           vstream(chi[ss+v]()(0)(1), p_01); | ||||
|           vstream(chi[ss+v]()(0)(2), p_02); | ||||
|           vstream(chi[ss+v]()(1)(0), p_10); | ||||
|           vstream(chi[ss+v]()(1)(1), p_11); | ||||
|           vstream(chi[ss+v]()(1)(2), p_12); | ||||
|           vstream(chi[ss+v]()(2)(0), p_20); | ||||
|           vstream(chi[ss+v]()(2)(1), p_21); | ||||
|           vstream(chi[ss+v]()(2)(2), p_22); | ||||
|           vstream(chi[ss+v]()(3)(0), p_30); | ||||
|           vstream(chi[ss+v]()(3)(1), p_31); | ||||
|           vstream(chi[ss+v]()(3)(2), p_32); | ||||
|  | ||||
|         } | ||||
|  | ||||
|       #endif | ||||
|  | ||||
|     } | ||||
|  | ||||
|     this->M5Dtime += usecond(); | ||||
|   } | ||||
|  | ||||
|   template<class Impl> | ||||
|   void MobiusEOFAFermion<Impl>::M5Ddag_shift(const FermionField& psi, const FermionField& phi, | ||||
|     FermionField& chi, std::vector<Coeff_t>& lower, std::vector<Coeff_t>& diag, std::vector<Coeff_t>& upper, | ||||
|     std::vector<Coeff_t>& shift_coeffs) | ||||
|   { | ||||
|     this->M5Ddag(psi, phi, chi, lower, diag, upper); | ||||
|  | ||||
|     // FIXME: possible gain from vectorizing shift operation as well? | ||||
|     Coeff_t one(1.0); | ||||
|     int Ls = this->Ls; | ||||
|     for(int s=0; s<Ls; s++){ | ||||
|       if(this->pm == 1){ axpby_ssp_pplus(chi, one, chi, shift_coeffs[s], psi, Ls-1, s); } | ||||
|       else{ axpby_ssp_pminus(chi, one, chi, shift_coeffs[s], psi, 0, s); } | ||||
|     } | ||||
|   } | ||||
|  | ||||
|   #ifdef AVX512 | ||||
|     #include<simd/Intel512common.h> | ||||
|     #include<simd/Intel512avx.h> | ||||
|     #include<simd/Intel512single.h> | ||||
|   #endif | ||||
|  | ||||
|   template<class Impl> | ||||
|   void MobiusEOFAFermion<Impl>::MooeeInternalAsm(const FermionField& psi, FermionField& chi, | ||||
|     int LLs, int site, Vector<iSinglet<Simd> >& Matp, Vector<iSinglet<Simd> >& Matm) | ||||
|   { | ||||
|     #ifndef AVX512 | ||||
|       { | ||||
|         SiteHalfSpinor BcastP; | ||||
|         SiteHalfSpinor BcastM; | ||||
|         SiteHalfSpinor SiteChiP; | ||||
|         SiteHalfSpinor SiteChiM; | ||||
|  | ||||
|         // Ls*Ls * 2 * 12 * vol flops | ||||
|         for(int s1=0; s1<LLs; s1++){ | ||||
|  | ||||
|           for(int s2=0; s2<LLs; s2++){ | ||||
|           for(int l=0; l < Simd::Nsimd(); l++){ // simd lane | ||||
|  | ||||
|             int s = s2 + l*LLs; | ||||
|             int lex = s2 + LLs*site; | ||||
|  | ||||
|             if( s2==0 && l==0 ){ | ||||
|               SiteChiP=zero; | ||||
|               SiteChiM=zero; | ||||
|             } | ||||
|  | ||||
|             for(int sp=0; sp<2;  sp++){ | ||||
|             for(int co=0; co<Nc; co++){ | ||||
|               vbroadcast(BcastP()(sp)(co), psi[lex]()(sp)(co), l); | ||||
|             }} | ||||
|  | ||||
|             for(int sp=0; sp<2;  sp++){ | ||||
|             for(int co=0; co<Nc; co++){ | ||||
|               vbroadcast(BcastM()(sp)(co), psi[lex]()(sp+2)(co), l); | ||||
|             }} | ||||
|  | ||||
|             for(int sp=0; sp<2;  sp++){ | ||||
|             for(int co=0; co<Nc; co++){ | ||||
|               SiteChiP()(sp)(co) = real_madd(Matp[LLs*s+s1]()()(), BcastP()(sp)(co), SiteChiP()(sp)(co)); // 1100 us. | ||||
|               SiteChiM()(sp)(co) = real_madd(Matm[LLs*s+s1]()()(), BcastM()(sp)(co), SiteChiM()(sp)(co)); // each found by commenting out | ||||
|             }} | ||||
|           }} | ||||
|  | ||||
|           { | ||||
|             int lex = s1 + LLs*site; | ||||
|             for(int sp=0; sp<2;  sp++){ | ||||
|             for(int co=0; co<Nc; co++){ | ||||
|               vstream(chi[lex]()(sp)(co),   SiteChiP()(sp)(co)); | ||||
|               vstream(chi[lex]()(sp+2)(co), SiteChiM()(sp)(co)); | ||||
|             }} | ||||
|           } | ||||
|         } | ||||
|       } | ||||
|     #else | ||||
|       { | ||||
|         // pointers | ||||
|         //  MASK_REGS; | ||||
|         #define Chi_00 %%zmm1 | ||||
|         #define Chi_01 %%zmm2 | ||||
|         #define Chi_02 %%zmm3 | ||||
|         #define Chi_10 %%zmm4 | ||||
|         #define Chi_11 %%zmm5 | ||||
|         #define Chi_12 %%zmm6 | ||||
|         #define Chi_20 %%zmm7 | ||||
|         #define Chi_21 %%zmm8 | ||||
|         #define Chi_22 %%zmm9 | ||||
|         #define Chi_30 %%zmm10 | ||||
|         #define Chi_31 %%zmm11 | ||||
|         #define Chi_32 %%zmm12 | ||||
|  | ||||
|         #define BCAST0  %%zmm13 | ||||
|         #define BCAST1  %%zmm14 | ||||
|         #define BCAST2  %%zmm15 | ||||
|         #define BCAST3  %%zmm16 | ||||
|         #define BCAST4  %%zmm17 | ||||
|         #define BCAST5  %%zmm18 | ||||
|         #define BCAST6  %%zmm19 | ||||
|         #define BCAST7  %%zmm20 | ||||
|         #define BCAST8  %%zmm21 | ||||
|         #define BCAST9  %%zmm22 | ||||
|         #define BCAST10 %%zmm23 | ||||
|         #define BCAST11 %%zmm24 | ||||
|  | ||||
|         int incr = LLs*LLs*sizeof(iSinglet<Simd>); | ||||
|  | ||||
|         for(int s1=0; s1<LLs; s1++){ | ||||
|  | ||||
|           for(int s2=0; s2<LLs; s2++){ | ||||
|  | ||||
|             int lex = s2 + LLs*site; | ||||
|             uint64_t a0 = (uint64_t) &Matp[LLs*s2+s1]; // should be cacheable | ||||
|             uint64_t a1 = (uint64_t) &Matm[LLs*s2+s1]; | ||||
|             uint64_t a2 = (uint64_t) &psi[lex]; | ||||
|  | ||||
|             for(int l=0; l<Simd::Nsimd(); l++){ // simd lane | ||||
|  | ||||
|               if((s2+l)==0) { | ||||
|                 asm( | ||||
|                       VPREFETCH1(0,%2)              VPREFETCH1(0,%1) | ||||
|                       VPREFETCH1(12,%2)  	          VPREFETCH1(13,%2) | ||||
|                       VPREFETCH1(14,%2)  	          VPREFETCH1(15,%2) | ||||
|                       VBCASTCDUP(0,%2,BCAST0) | ||||
|                       VBCASTCDUP(1,%2,BCAST1) | ||||
|                       VBCASTCDUP(2,%2,BCAST2) | ||||
|                       VBCASTCDUP(3,%2,BCAST3) | ||||
|                       VBCASTCDUP(4,%2,BCAST4)       VMULMEM(0,%0,BCAST0,Chi_00) | ||||
|                       VBCASTCDUP(5,%2,BCAST5)       VMULMEM(0,%0,BCAST1,Chi_01) | ||||
|                       VBCASTCDUP(6,%2,BCAST6)       VMULMEM(0,%0,BCAST2,Chi_02) | ||||
|                       VBCASTCDUP(7,%2,BCAST7)       VMULMEM(0,%0,BCAST3,Chi_10) | ||||
|                       VBCASTCDUP(8,%2,BCAST8)       VMULMEM(0,%0,BCAST4,Chi_11) | ||||
|                       VBCASTCDUP(9,%2,BCAST9)       VMULMEM(0,%0,BCAST5,Chi_12) | ||||
|                       VBCASTCDUP(10,%2,BCAST10)     VMULMEM(0,%1,BCAST6,Chi_20) | ||||
|                       VBCASTCDUP(11,%2,BCAST11)     VMULMEM(0,%1,BCAST7,Chi_21) | ||||
|                       VMULMEM(0,%1,BCAST8,Chi_22) | ||||
|                       VMULMEM(0,%1,BCAST9,Chi_30) | ||||
|                       VMULMEM(0,%1,BCAST10,Chi_31) | ||||
|                       VMULMEM(0,%1,BCAST11,Chi_32) | ||||
|                       : : "r" (a0), "r" (a1), "r" (a2)                            ); | ||||
|               } else { | ||||
|                 asm( | ||||
|                       VBCASTCDUP(0,%2,BCAST0)   VMADDMEM(0,%0,BCAST0,Chi_00) | ||||
|                       VBCASTCDUP(1,%2,BCAST1)   VMADDMEM(0,%0,BCAST1,Chi_01) | ||||
|                       VBCASTCDUP(2,%2,BCAST2)   VMADDMEM(0,%0,BCAST2,Chi_02) | ||||
|                       VBCASTCDUP(3,%2,BCAST3)   VMADDMEM(0,%0,BCAST3,Chi_10) | ||||
|                       VBCASTCDUP(4,%2,BCAST4)   VMADDMEM(0,%0,BCAST4,Chi_11) | ||||
|                       VBCASTCDUP(5,%2,BCAST5)   VMADDMEM(0,%0,BCAST5,Chi_12) | ||||
|                       VBCASTCDUP(6,%2,BCAST6)   VMADDMEM(0,%1,BCAST6,Chi_20) | ||||
|                       VBCASTCDUP(7,%2,BCAST7)   VMADDMEM(0,%1,BCAST7,Chi_21) | ||||
|                       VBCASTCDUP(8,%2,BCAST8)   VMADDMEM(0,%1,BCAST8,Chi_22) | ||||
|                       VBCASTCDUP(9,%2,BCAST9)   VMADDMEM(0,%1,BCAST9,Chi_30) | ||||
|                       VBCASTCDUP(10,%2,BCAST10) VMADDMEM(0,%1,BCAST10,Chi_31) | ||||
|                       VBCASTCDUP(11,%2,BCAST11) VMADDMEM(0,%1,BCAST11,Chi_32) | ||||
|                       : : "r" (a0), "r" (a1), "r" (a2)                            ); | ||||
|               } | ||||
|  | ||||
|               a0 = a0 + incr; | ||||
|               a1 = a1 + incr; | ||||
|               a2 = a2 + sizeof(Simd::scalar_type); | ||||
|             } | ||||
|           } | ||||
|  | ||||
|           { | ||||
|             int lexa = s1+LLs*site; | ||||
|             asm ( | ||||
|                VSTORE(0,%0,Chi_00) VSTORE(1 ,%0,Chi_01)  VSTORE(2 ,%0,Chi_02) | ||||
|                VSTORE(3,%0,Chi_10) VSTORE(4 ,%0,Chi_11)  VSTORE(5 ,%0,Chi_12) | ||||
|                VSTORE(6,%0,Chi_20) VSTORE(7 ,%0,Chi_21)  VSTORE(8 ,%0,Chi_22) | ||||
|                VSTORE(9,%0,Chi_30) VSTORE(10,%0,Chi_31)  VSTORE(11,%0,Chi_32) | ||||
|                : : "r" ((uint64_t)&chi[lexa]) : "memory" ); | ||||
|           } | ||||
|         } | ||||
|       } | ||||
|  | ||||
|       #undef Chi_00 | ||||
|       #undef Chi_01 | ||||
|       #undef Chi_02 | ||||
|       #undef Chi_10 | ||||
|       #undef Chi_11 | ||||
|       #undef Chi_12 | ||||
|       #undef Chi_20 | ||||
|       #undef Chi_21 | ||||
|       #undef Chi_22 | ||||
|       #undef Chi_30 | ||||
|       #undef Chi_31 | ||||
|       #undef Chi_32 | ||||
|  | ||||
|       #undef BCAST0 | ||||
|       #undef BCAST1 | ||||
|       #undef BCAST2 | ||||
|       #undef BCAST3 | ||||
|       #undef BCAST4 | ||||
|       #undef BCAST5 | ||||
|       #undef BCAST6 | ||||
|       #undef BCAST7 | ||||
|       #undef BCAST8 | ||||
|       #undef BCAST9 | ||||
|       #undef BCAST10 | ||||
|       #undef BCAST11 | ||||
|  | ||||
|     #endif | ||||
|   }; | ||||
|  | ||||
|   // Z-mobius version | ||||
|   template<class Impl> | ||||
|   void MobiusEOFAFermion<Impl>::MooeeInternalZAsm(const FermionField& psi, FermionField& chi, | ||||
|     int LLs, int site, Vector<iSinglet<Simd> >& Matp, Vector<iSinglet<Simd> >& Matm) | ||||
|   { | ||||
|     std::cout << "Error: zMobius not implemented for EOFA" << std::endl; | ||||
|     exit(-1); | ||||
|   }; | ||||
|  | ||||
|   template<class Impl> | ||||
|   void MobiusEOFAFermion<Impl>::MooeeInternal(const FermionField& psi, FermionField& chi, int dag, int inv) | ||||
|   { | ||||
|     int Ls  = this->Ls; | ||||
|     int LLs = psi._grid->_rdimensions[0]; | ||||
|     int vol = psi._grid->oSites()/LLs; | ||||
|  | ||||
|     chi.checkerboard = psi.checkerboard; | ||||
|  | ||||
|     Vector<iSinglet<Simd>>   Matp; | ||||
|     Vector<iSinglet<Simd>>   Matm; | ||||
|     Vector<iSinglet<Simd>>* _Matp; | ||||
|     Vector<iSinglet<Simd>>* _Matm; | ||||
|  | ||||
|     //  MooeeInternalCompute(dag,inv,Matp,Matm); | ||||
|     if(inv && dag){ | ||||
|       _Matp = &this->MatpInvDag; | ||||
|       _Matm = &this->MatmInvDag; | ||||
|     } | ||||
|  | ||||
|     if(inv && (!dag)){ | ||||
|       _Matp = &this->MatpInv; | ||||
|       _Matm = &this->MatmInv; | ||||
|     } | ||||
|  | ||||
|     if(!inv){ | ||||
|       MooeeInternalCompute(dag, inv, Matp, Matm); | ||||
|       _Matp = &Matp; | ||||
|       _Matm = &Matm; | ||||
|     } | ||||
|  | ||||
|     assert(_Matp->size() == Ls*LLs); | ||||
|  | ||||
|     this->MooeeInvCalls++; | ||||
|     this->MooeeInvTime -= usecond(); | ||||
|  | ||||
|     if(switcheroo<Coeff_t>::iscomplex()){ | ||||
|       parallel_for(auto site=0; site<vol; site++){ | ||||
|         MooeeInternalZAsm(psi, chi, LLs, site, *_Matp, *_Matm); | ||||
|       } | ||||
|     } else { | ||||
|       parallel_for(auto site=0; site<vol; site++){ | ||||
|         MooeeInternalAsm(psi, chi, LLs, site, *_Matp, *_Matm); | ||||
|       } | ||||
|     } | ||||
|  | ||||
|     this->MooeeInvTime += usecond(); | ||||
|   } | ||||
|  | ||||
|   #ifdef MOBIUS_EOFA_DPERP_VEC | ||||
|  | ||||
|     INSTANTIATE_DPERP_MOBIUS_EOFA(DomainWallVec5dImplD); | ||||
|     INSTANTIATE_DPERP_MOBIUS_EOFA(DomainWallVec5dImplF); | ||||
|     INSTANTIATE_DPERP_MOBIUS_EOFA(ZDomainWallVec5dImplD); | ||||
|     INSTANTIATE_DPERP_MOBIUS_EOFA(ZDomainWallVec5dImplF); | ||||
|  | ||||
|     INSTANTIATE_DPERP_MOBIUS_EOFA(DomainWallVec5dImplDF); | ||||
|     INSTANTIATE_DPERP_MOBIUS_EOFA(DomainWallVec5dImplFH); | ||||
|     INSTANTIATE_DPERP_MOBIUS_EOFA(ZDomainWallVec5dImplDF); | ||||
|     INSTANTIATE_DPERP_MOBIUS_EOFA(ZDomainWallVec5dImplFH); | ||||
|  | ||||
|     template void MobiusEOFAFermion<DomainWallVec5dImplF>::MooeeInternal(const FermionField& psi, FermionField& chi, int dag, int inv); | ||||
|     template void MobiusEOFAFermion<DomainWallVec5dImplD>::MooeeInternal(const FermionField& psi, FermionField& chi, int dag, int inv); | ||||
|     template void MobiusEOFAFermion<ZDomainWallVec5dImplF>::MooeeInternal(const FermionField& psi, FermionField& chi, int dag, int inv); | ||||
|     template void MobiusEOFAFermion<ZDomainWallVec5dImplD>::MooeeInternal(const FermionField& psi, FermionField& chi, int dag, int inv); | ||||
|  | ||||
|     template void MobiusEOFAFermion<DomainWallVec5dImplFH>::MooeeInternal(const FermionField& psi, FermionField& chi, int dag, int inv); | ||||
|     template void MobiusEOFAFermion<DomainWallVec5dImplDF>::MooeeInternal(const FermionField& psi, FermionField& chi, int dag, int inv); | ||||
|     template void MobiusEOFAFermion<ZDomainWallVec5dImplFH>::MooeeInternal(const FermionField& psi, FermionField& chi, int dag, int inv); | ||||
|     template void MobiusEOFAFermion<ZDomainWallVec5dImplDF>::MooeeInternal(const FermionField& psi, FermionField& chi, int dag, int inv); | ||||
|  | ||||
|   #endif | ||||
|  | ||||
| }} | ||||
							
								
								
									
										241
									
								
								tests/core/Test_mobius_eofa_even_odd.cc
									
									
									
									
									
										Normal file
									
								
							
							
						
						
									
										241
									
								
								tests/core/Test_mobius_eofa_even_odd.cc
									
									
									
									
									
										Normal file
									
								
							| @@ -0,0 +1,241 @@ | ||||
| /************************************************************************************* | ||||
|  | ||||
| Grid physics library, www.github.com/paboyle/Grid | ||||
|  | ||||
| Source file: ./tests/core/Test_dwf_eofa_even_odd.cc | ||||
|  | ||||
| Copyright (C) 2017 | ||||
|  | ||||
| Author: Peter Boyle <paboyle@ph.ed.ac.uk> | ||||
| Author: paboyle <paboyle@ph.ed.ac.uk> | ||||
| Author: David Murphy <dmurphy@phys.columbia.edu> | ||||
|  | ||||
| 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; | ||||
| using namespace Grid::QCD; | ||||
|  | ||||
| template<class d> | ||||
| struct scal { | ||||
|     d internal; | ||||
| }; | ||||
|  | ||||
| Gamma::Algebra Gmu [] = { | ||||
|     Gamma::Algebra::GammaX, | ||||
|     Gamma::Algebra::GammaY, | ||||
|     Gamma::Algebra::GammaZ, | ||||
|     Gamma::Algebra::GammaT | ||||
| }; | ||||
|  | ||||
| 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; | ||||
|  | ||||
|     const int Ls = 8; | ||||
|     // GridCartesian*         UGrid   = SpaceTimeGrid::makeFourDimGrid(GridDefaultLatt(), GridDefaultSimd(Nd,vComplex::Nsimd()), GridDefaultMpi()); | ||||
|     GridCartesian*         UGrid   = SpaceTimeGrid::makeFourDimGrid(GridDefaultLatt(), GridDefaultSimd(Nd,vComplex::Nsimd()), GridDefaultMpi()); | ||||
|     GridCartesian*         FGrid   = SpaceTimeGrid::makeFiveDimGrid(Ls, UGrid); | ||||
|     GridRedBlackCartesian* UrbGrid = SpaceTimeGrid::makeFourDimRedBlackGrid(UGrid); | ||||
|     GridRedBlackCartesian* FrbGrid = SpaceTimeGrid::makeFiveDimRedBlackGrid(Ls, UGrid); | ||||
|  | ||||
|     std::vector<int> seeds4({1,2,3,4}); | ||||
|     std::vector<int> seeds5({5,6,7,8}); | ||||
|  | ||||
|     GridParallelRNG RNG4(UGrid); RNG4.SeedFixedIntegers(seeds4); | ||||
|     GridParallelRNG RNG5(FGrid); RNG5.SeedFixedIntegers(seeds5); | ||||
|  | ||||
|     LatticeFermion    src   (FGrid); random(RNG5, src); | ||||
|     LatticeFermion    phi   (FGrid); random(RNG5, phi); | ||||
|     LatticeFermion    chi   (FGrid); random(RNG5, chi); | ||||
|     LatticeFermion    result(FGrid); result = zero; | ||||
|     LatticeFermion    ref   (FGrid); ref = zero; | ||||
|     LatticeFermion    tmp   (FGrid); tmp = zero; | ||||
|     LatticeFermion    err   (FGrid); err = zero; | ||||
|     LatticeGaugeField Umu   (UGrid); SU3::HotConfiguration(RNG4, Umu); | ||||
|     std::vector<LatticeColourMatrix> U(4,UGrid); | ||||
|  | ||||
|     // Only one non-zero (y) | ||||
|     Umu = zero; | ||||
|     for(int nn=0; nn<Nd; nn++){ | ||||
|         random(RNG4, U[nn]); | ||||
|         if(nn>0){ U[nn] = zero; } | ||||
|         PokeIndex<LorentzIndex>(Umu, U[nn], nn); | ||||
|     } | ||||
|  | ||||
|     RealD b     = 2.5; | ||||
|     RealD c     = 1.5; | ||||
|     RealD mq1   = 0.1; | ||||
|     RealD mq2   = 0.5; | ||||
|     RealD mq3   = 1.0; | ||||
|     RealD shift = 0.1234; | ||||
|     RealD M5    = 1.8; | ||||
|     int   pm    = 1; | ||||
|     MobiusEOFAFermionR Ddwf(Umu, *FGrid, *FrbGrid, *UGrid, *UrbGrid, mq1, mq2, mq3, shift, pm, M5, b, c); | ||||
|  | ||||
|     LatticeFermion src_e (FrbGrid); | ||||
|     LatticeFermion src_o (FrbGrid); | ||||
|     LatticeFermion r_e   (FrbGrid); | ||||
|     LatticeFermion r_o   (FrbGrid); | ||||
|     LatticeFermion r_eo  (FGrid); | ||||
|     LatticeFermion r_eeoo(FGrid); | ||||
|  | ||||
|     std::cout << GridLogMessage << "==========================================================" << std::endl; | ||||
|     std::cout << GridLogMessage << "= Testing that Meo + Moe + Moo + Mee = Munprec " << std::endl; | ||||
|     std::cout << GridLogMessage << "==========================================================" << std::endl; | ||||
|  | ||||
|     pickCheckerboard(Even, src_e, src); | ||||
|     pickCheckerboard(Odd,  src_o, src); | ||||
|  | ||||
|     Ddwf.Meooe(src_e, r_o); std::cout << GridLogMessage << "Applied Meo" << std::endl; | ||||
|     Ddwf.Meooe(src_o, r_e); std::cout << GridLogMessage << "Applied Moe" << std::endl; | ||||
|     setCheckerboard(r_eo, r_o); | ||||
|     setCheckerboard(r_eo, r_e); | ||||
|  | ||||
|     Ddwf.Mooee(src_e, r_e); std::cout << GridLogMessage << "Applied Mee" << std::endl; | ||||
|     Ddwf.Mooee(src_o, r_o); std::cout << GridLogMessage << "Applied Moo" << std::endl; | ||||
|     setCheckerboard(r_eeoo, r_e); | ||||
|     setCheckerboard(r_eeoo, r_o); | ||||
|  | ||||
|     r_eo = r_eo + r_eeoo; | ||||
|     Ddwf.M(src, ref); | ||||
|  | ||||
|     // std::cout << GridLogMessage << r_eo << std::endl; | ||||
|     // std::cout << GridLogMessage << ref  << std::endl; | ||||
|  | ||||
|     err = ref - r_eo; | ||||
|     std::cout << GridLogMessage << "EO norm diff   " << norm2(err) << " " << norm2(ref) << " " << norm2(r_eo) << std::endl; | ||||
|  | ||||
|     LatticeComplex cerr(FGrid); | ||||
|     cerr = localInnerProduct(err,err); | ||||
|     // std::cout << GridLogMessage << cerr << std::endl; | ||||
|  | ||||
|     std::cout << GridLogMessage << "==============================================================" << std::endl; | ||||
|     std::cout << GridLogMessage << "= Test Ddagger is the dagger of D by requiring                " << std::endl; | ||||
|     std::cout << GridLogMessage << "=  < phi | Deo | chi > * = < chi | Deo^dag| phi>  " << std::endl; | ||||
|     std::cout << GridLogMessage << "==============================================================" << std::endl; | ||||
|  | ||||
|     LatticeFermion chi_e (FrbGrid); | ||||
|     LatticeFermion chi_o (FrbGrid); | ||||
|  | ||||
|     LatticeFermion dchi_e(FrbGrid); | ||||
|     LatticeFermion dchi_o(FrbGrid); | ||||
|  | ||||
|     LatticeFermion phi_e (FrbGrid); | ||||
|     LatticeFermion phi_o (FrbGrid); | ||||
|  | ||||
|     LatticeFermion dphi_e(FrbGrid); | ||||
|     LatticeFermion dphi_o(FrbGrid); | ||||
|  | ||||
|     pickCheckerboard(Even, chi_e, chi); | ||||
|     pickCheckerboard(Odd , chi_o, chi); | ||||
|     pickCheckerboard(Even, phi_e, phi); | ||||
|     pickCheckerboard(Odd , phi_o, phi); | ||||
|  | ||||
|     Ddwf.Meooe   (chi_e, dchi_o); | ||||
|     Ddwf.Meooe   (chi_o, dchi_e); | ||||
|     Ddwf.MeooeDag(phi_e, dphi_o); | ||||
|     Ddwf.MeooeDag(phi_o, dphi_e); | ||||
|  | ||||
|     ComplexD pDce = innerProduct(phi_e, dchi_e); | ||||
|     ComplexD pDco = innerProduct(phi_o, dchi_o); | ||||
|     ComplexD cDpe = innerProduct(chi_e, dphi_e); | ||||
|     ComplexD cDpo = innerProduct(chi_o, dphi_o); | ||||
|  | ||||
|     std::cout << GridLogMessage << "e " << pDce << " " << cDpe << std::endl; | ||||
|     std::cout << GridLogMessage << "o " << pDco << " " << cDpo << std::endl; | ||||
|  | ||||
|     std::cout << GridLogMessage << "pDce - conj(cDpo) " << pDce-conj(cDpo) << std::endl; | ||||
|     std::cout << GridLogMessage << "pDco - conj(cDpe) " << pDco-conj(cDpe) << std::endl; | ||||
|  | ||||
|     std::cout << GridLogMessage << "==============================================================" << std::endl; | ||||
|     std::cout << GridLogMessage << "= Test MeeInv Mee = 1                                         " << std::endl; | ||||
|     std::cout << GridLogMessage << "==============================================================" << std::endl; | ||||
|  | ||||
|     pickCheckerboard(Even, chi_e, chi); | ||||
|     pickCheckerboard(Odd , chi_o, chi); | ||||
|  | ||||
|     Ddwf.Mooee   (chi_e, src_e); | ||||
|     Ddwf.MooeeInv(src_e, phi_e); | ||||
|  | ||||
|     Ddwf.Mooee   (chi_o, src_o); | ||||
|     Ddwf.MooeeInv(src_o, phi_o); | ||||
|  | ||||
|     setCheckerboard(phi, phi_e); | ||||
|     setCheckerboard(phi, phi_o); | ||||
|  | ||||
|     err = phi - chi; | ||||
|     std::cout << GridLogMessage << "norm diff   " << norm2(err) << std::endl; | ||||
|  | ||||
|     std::cout << GridLogMessage << "==============================================================" << std::endl; | ||||
|     std::cout << GridLogMessage << "= Test MeeInvDag MeeDag = 1                                   " << std::endl; | ||||
|     std::cout << GridLogMessage << "==============================================================" << std::endl; | ||||
|  | ||||
|     pickCheckerboard(Even, chi_e, chi); | ||||
|     pickCheckerboard(Odd , chi_o, chi); | ||||
|  | ||||
|     Ddwf.MooeeDag   (chi_e, src_e); | ||||
|     Ddwf.MooeeInvDag(src_e, phi_e); | ||||
|  | ||||
|     Ddwf.MooeeDag   (chi_o, src_o); | ||||
|     Ddwf.MooeeInvDag(src_o, phi_o); | ||||
|  | ||||
|     setCheckerboard(phi, phi_e); | ||||
|     setCheckerboard(phi, phi_o); | ||||
|  | ||||
|     err = phi - chi; | ||||
|     std::cout << GridLogMessage << "norm diff   " << norm2(err) << std::endl; | ||||
|  | ||||
|     std::cout << GridLogMessage << "==============================================================" << std::endl; | ||||
|     std::cout << GridLogMessage << "= Test MpcDagMpc is Hermitian              " << std::endl; | ||||
|     std::cout << GridLogMessage << "==============================================================" << std::endl; | ||||
|  | ||||
|     random(RNG5, phi); | ||||
|     random(RNG5, chi); | ||||
|     pickCheckerboard(Even, chi_e, chi); | ||||
|     pickCheckerboard(Odd , chi_o, chi); | ||||
|     pickCheckerboard(Even, phi_e, phi); | ||||
|     pickCheckerboard(Odd , phi_o, phi); | ||||
|     RealD t1,t2; | ||||
|  | ||||
|     SchurDiagMooeeOperator<MobiusEOFAFermionR,LatticeFermion> HermOpEO(Ddwf); | ||||
|     HermOpEO.MpcDagMpc(chi_e, dchi_e, t1, t2); | ||||
|     HermOpEO.MpcDagMpc(chi_o, dchi_o, t1, t2); | ||||
|  | ||||
|     HermOpEO.MpcDagMpc(phi_e, dphi_e, t1, t2); | ||||
|     HermOpEO.MpcDagMpc(phi_o, dphi_o, t1, t2); | ||||
|  | ||||
|     pDce = innerProduct(phi_e, dchi_e); | ||||
|     pDco = innerProduct(phi_o, dchi_o); | ||||
|     cDpe = innerProduct(chi_e, dphi_e); | ||||
|     cDpo = innerProduct(chi_o, dphi_o); | ||||
|  | ||||
|     std::cout << GridLogMessage << "e " << pDce << " " << cDpe << std::endl; | ||||
|     std::cout << GridLogMessage << "o " << pDco << " " << cDpo << std::endl; | ||||
|  | ||||
|     std::cout << GridLogMessage << "pDce - conj(cDpo) " << pDco-conj(cDpo) << std::endl; | ||||
|     std::cout << GridLogMessage << "pDco - conj(cDpe) " << pDce-conj(cDpe) << std::endl; | ||||
|  | ||||
|     Grid_finalize(); | ||||
| } | ||||
							
								
								
									
										104
									
								
								tests/debug/Test_heatbath_mobius_eofa.cc
									
									
									
									
									
										Normal file
									
								
							
							
						
						
									
										104
									
								
								tests/debug/Test_heatbath_mobius_eofa.cc
									
									
									
									
									
										Normal file
									
								
							| @@ -0,0 +1,104 @@ | ||||
| /************************************************************************************* | ||||
|  | ||||
| Grid physics library, www.github.com/paboyle/Grid | ||||
|  | ||||
| Source file: ./tests/debug/Test_heatbath_dwf_eofa.cc | ||||
|  | ||||
| Copyright (C) 2017 | ||||
|  | ||||
| Author: Peter Boyle <paboyle@ph.ed.ac.uk> | ||||
| Author: paboyle <paboyle@ph.ed.ac.uk> | ||||
| Author: David Murphy <dmurphy@phys.columbia.edu> | ||||
|  | ||||
| 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 */ | ||||
|  | ||||
| ////////////////////////////////////////////////////////////////////////////////////////// | ||||
| // This program sets up the initial pseudofermion field |Phi> = Meofa^{-1/2}*|eta>, and | ||||
| // then uses this Phi to compute the action <Phi|Meofa|Phi>. | ||||
| // If all is working, one should find that <eta|eta> = <Phi|Meofa|Phi>. | ||||
| ////////////////////////////////////////////////////////////////////////////////////////// | ||||
|  | ||||
| #include <Grid/Grid.h> | ||||
|  | ||||
| using namespace std; | ||||
| using namespace Grid; | ||||
| using namespace Grid::QCD; | ||||
|  | ||||
| // Parameters for test | ||||
| const std::vector<int> grid_dim = { 8, 8, 8, 8 }; | ||||
| const int              Ls       = 8; | ||||
| const int              Npoles   = 12; | ||||
| const RealD            b        = 2.5; | ||||
| const RealD            c        = 1.5; | ||||
| const RealD            mf       = 0.01; | ||||
| const RealD            mpv      = 1.0; | ||||
| const RealD            M5       = 1.8; | ||||
|  | ||||
| int main(int argc, char** argv) | ||||
| { | ||||
|   Grid_init(&argc, &argv); | ||||
|  | ||||
|   int threads = GridThread::GetThreads(); | ||||
|   std::cout << GridLogMessage << "Grid is set up to use " << threads << " threads" << std::endl; | ||||
|  | ||||
|   // Initialize spacetime grid | ||||
|   std::cout << GridLogMessage << "Lattice dimensions: " << grid_dim << "  Ls: " << Ls << std::endl; | ||||
|   GridCartesian*         UGrid   = SpaceTimeGrid::makeFourDimGrid(grid_dim, | ||||
|                                     GridDefaultSimd(Nd,vComplex::Nsimd()), GridDefaultMpi()); | ||||
|   GridRedBlackCartesian* UrbGrid = SpaceTimeGrid::makeFourDimRedBlackGrid(UGrid); | ||||
|   GridCartesian*         FGrid   = SpaceTimeGrid::makeFiveDimGrid(Ls, UGrid); | ||||
|   GridRedBlackCartesian* FrbGrid = SpaceTimeGrid::makeFiveDimRedBlackGrid(Ls, UGrid); | ||||
|  | ||||
|   // Set up RNGs | ||||
|   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); | ||||
|   RNG4.SeedFixedIntegers(seeds4); | ||||
|  | ||||
|   // Random gauge field | ||||
|   LatticeGaugeField Umu(UGrid); | ||||
|   SU3::HotConfiguration(RNG4, Umu); | ||||
|  | ||||
|   MobiusEOFAFermionR Lop(Umu, *FGrid, *FrbGrid, *UGrid, *UrbGrid, mf,  mf, mpv,  0.0, -1, M5, b, c); | ||||
|   MobiusEOFAFermionR Rop(Umu, *FGrid, *FrbGrid, *UGrid, *UrbGrid, mpv, mf, mpv, -1.0,  1, M5, b, c); | ||||
|  | ||||
|   // Construct the action and test the heatbath (zero initial guess) | ||||
|   { | ||||
|     OneFlavourRationalParams Params(0.95, 100.0, 5000, 1.0e-12, Npoles); | ||||
|     ConjugateGradient<LatticeFermion> CG(1.0e-12, 5000); | ||||
|     ExactOneFlavourRatioPseudoFermionAction<WilsonImplR> Meofa(Lop, Rop, CG, Params, false); | ||||
|  | ||||
|     Meofa.refresh(Umu, RNG5); | ||||
|     printf("<Phi|Meofa|Phi> = %1.15e\n", Meofa.S(Umu)); | ||||
|   } | ||||
|  | ||||
|   // Construct the action and test the heatbath (forecasted initial guesses) | ||||
|   { | ||||
|     OneFlavourRationalParams Params(0.95, 100.0, 5000, 1.0e-12, Npoles); | ||||
|     ConjugateGradient<LatticeFermion> CG(1.0e-12, 5000); | ||||
|     ExactOneFlavourRatioPseudoFermionAction<WilsonImplR> Meofa(Lop, Rop, CG, Params, true); | ||||
|  | ||||
|     Meofa.refresh(Umu, RNG5); | ||||
|     printf("<Phi|Meofa|Phi> = %1.15e\n", Meofa.S(Umu)); | ||||
|   } | ||||
|  | ||||
|   return 0; | ||||
| } | ||||
							
								
								
									
										109
									
								
								tests/debug/Test_heatbath_mobius_eofa_gparity.cc
									
									
									
									
									
										Normal file
									
								
							
							
						
						
									
										109
									
								
								tests/debug/Test_heatbath_mobius_eofa_gparity.cc
									
									
									
									
									
										Normal file
									
								
							| @@ -0,0 +1,109 @@ | ||||
| /************************************************************************************* | ||||
|  | ||||
| Grid physics library, www.github.com/paboyle/Grid | ||||
|  | ||||
| Source file: ./tests/debug/Test_heatbath_dwf_eofa.cc | ||||
|  | ||||
| Copyright (C) 2017 | ||||
|  | ||||
| Author: Peter Boyle <paboyle@ph.ed.ac.uk> | ||||
| Author: paboyle <paboyle@ph.ed.ac.uk> | ||||
| Author: David Murphy <dmurphy@phys.columbia.edu> | ||||
|  | ||||
| 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 */ | ||||
|  | ||||
| ////////////////////////////////////////////////////////////////////////////////////////// | ||||
| // This program sets up the initial pseudofermion field |Phi> = Meofa^{-1/2}*|eta>, and | ||||
| // then uses this Phi to compute the action <Phi|Meofa|Phi>. | ||||
| // If all is working, one should find that <eta|eta> = <Phi|Meofa|Phi>. | ||||
| ////////////////////////////////////////////////////////////////////////////////////////// | ||||
|  | ||||
| #include <Grid/Grid.h> | ||||
|  | ||||
| using namespace std; | ||||
| using namespace Grid; | ||||
| using namespace Grid::QCD; | ||||
|  | ||||
| typedef GparityWilsonImplR FermionImplPolicy; | ||||
| typedef GparityMobiusEOFAFermionR FermionAction; | ||||
| typedef typename FermionAction::FermionField FermionField; | ||||
|  | ||||
| // Parameters for test | ||||
| const std::vector<int> grid_dim = { 8, 8, 8, 8 }; | ||||
| const int              Ls       = 8; | ||||
| const int              Npoles   = 12; | ||||
| const RealD            b        = 2.5; | ||||
| const RealD            c        = 1.5; | ||||
| const RealD            mf       = 0.01; | ||||
| const RealD            mpv      = 1.0; | ||||
| const RealD            M5       = 1.8; | ||||
|  | ||||
| int main(int argc, char** argv) | ||||
| { | ||||
|   Grid_init(&argc, &argv); | ||||
|  | ||||
|   int threads = GridThread::GetThreads(); | ||||
|   std::cout << GridLogMessage << "Grid is set up to use " << threads << " threads" << std::endl; | ||||
|  | ||||
|   // Initialize spacetime grid | ||||
|   std::cout << GridLogMessage << "Lattice dimensions: " << grid_dim << "  Ls: " << Ls << std::endl; | ||||
|   GridCartesian*         UGrid   = SpaceTimeGrid::makeFourDimGrid(grid_dim, | ||||
|                                     GridDefaultSimd(Nd,vComplex::Nsimd()), GridDefaultMpi()); | ||||
|   GridRedBlackCartesian* UrbGrid = SpaceTimeGrid::makeFourDimRedBlackGrid(UGrid); | ||||
|   GridCartesian*         FGrid   = SpaceTimeGrid::makeFiveDimGrid(Ls, UGrid); | ||||
|   GridRedBlackCartesian* FrbGrid = SpaceTimeGrid::makeFiveDimRedBlackGrid(Ls, UGrid); | ||||
|  | ||||
|   // Set up RNGs | ||||
|   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); | ||||
|   RNG4.SeedFixedIntegers(seeds4); | ||||
|  | ||||
|   // Random gauge field | ||||
|   LatticeGaugeField Umu(UGrid); | ||||
|   SU3::HotConfiguration(RNG4, Umu); | ||||
|  | ||||
|   FermionAction::ImplParams params; | ||||
|   FermionAction Lop(Umu, *FGrid, *FrbGrid, *UGrid, *UrbGrid, mf,  mf, mpv,  0.0, -1, M5, b, c, params); | ||||
|   FermionAction Rop(Umu, *FGrid, *FrbGrid, *UGrid, *UrbGrid, mpv, mf, mpv, -1.0,  1, M5, b, c, params); | ||||
|  | ||||
|   // Construct the action and test the heatbath (zero initial guess) | ||||
|   { | ||||
|     OneFlavourRationalParams Params(0.95, 100.0, 5000, 1.0e-12, Npoles); | ||||
|     ConjugateGradient<FermionField> CG(1.0e-12, 5000); | ||||
|     ExactOneFlavourRatioPseudoFermionAction<FermionImplPolicy> Meofa(Lop, Rop, CG, Params, false); | ||||
|  | ||||
|     Meofa.refresh(Umu, RNG5); | ||||
|     printf("<Phi|Meofa|Phi> = %1.15e\n", Meofa.S(Umu)); | ||||
|   } | ||||
|  | ||||
|   // Construct the action and test the heatbath (forecasted initial guesses) | ||||
|   { | ||||
|     OneFlavourRationalParams Params(0.95, 100.0, 5000, 1.0e-12, Npoles); | ||||
|     ConjugateGradient<FermionField> CG(1.0e-12, 5000); | ||||
|     ExactOneFlavourRatioPseudoFermionAction<FermionImplPolicy> Meofa(Lop, Rop, CG, Params, true); | ||||
|  | ||||
|     Meofa.refresh(Umu, RNG5); | ||||
|     printf("<Phi|Meofa|Phi> = %1.15e\n", Meofa.S(Umu)); | ||||
|   } | ||||
|  | ||||
|   return 0; | ||||
| } | ||||
| @@ -2,7 +2,7 @@ | ||||
|  | ||||
| Grid physics library, www.github.com/paboyle/Grid | ||||
|  | ||||
| Source file: ./tests/debug/Test_reweight_dwf_eofa.cc | ||||
| Source file: ./tests/debug/Test_reweight_dwf_eofa_gparity.cc | ||||
|  | ||||
| Copyright (C) 2017 | ||||
|  | ||||
|   | ||||
							
								
								
									
										215
									
								
								tests/debug/Test_reweight_mobius_eofa.cc
									
									
									
									
									
										Normal file
									
								
							
							
						
						
									
										215
									
								
								tests/debug/Test_reweight_mobius_eofa.cc
									
									
									
									
									
										Normal file
									
								
							| @@ -0,0 +1,215 @@ | ||||
| /************************************************************************************* | ||||
|  | ||||
| Grid physics library, www.github.com/paboyle/Grid | ||||
|  | ||||
| Source file: ./tests/debug/Test_reweight_dwf_eofa.cc | ||||
|  | ||||
| Copyright (C) 2017 | ||||
|  | ||||
| Author: Peter Boyle <paboyle@ph.ed.ac.uk> | ||||
| Author: paboyle <paboyle@ph.ed.ac.uk> | ||||
| Author: David Murphy <dmurphy@phys.columbia.edu> | ||||
|  | ||||
| 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; | ||||
| using namespace Grid::QCD; | ||||
|  | ||||
| // parameters for test | ||||
| const std::vector<int> grid_dim = { 8, 8, 8, 8 }; | ||||
| const int Ls = 8; | ||||
| const int Nhits = 10; | ||||
| const int max_iter = 5000; | ||||
| const RealD b  = 2.5; | ||||
| const RealD c  = 1.5; | ||||
| const RealD mf = 0.1; | ||||
| const RealD mb = 0.11; | ||||
| const RealD M5 = 1.8; | ||||
| const RealD stop_tol = 1.0e-12; | ||||
|  | ||||
| RealD mean(const std::vector<RealD>& data) | ||||
| { | ||||
|     int N = data.size(); | ||||
|     RealD mean(0.0); | ||||
|     for(int i=0; i<N; ++i){ mean += data[i]; } | ||||
|     return mean/RealD(N); | ||||
| } | ||||
|  | ||||
| RealD jack_mean(const std::vector<RealD>& data, int sample) | ||||
| { | ||||
|     int N = data.size(); | ||||
|     RealD mean(0.0); | ||||
|     for(int i=0; i<N; ++i){ if(i != sample){ mean += data[i]; } } | ||||
|     return mean/RealD(N-1); | ||||
| } | ||||
|  | ||||
| RealD jack_std(const std::vector<RealD>& jacks, RealD mean) | ||||
| { | ||||
|     int N = jacks.size(); | ||||
|     RealD std(0.0); | ||||
|     for(int i=0; i<N; ++i){ std += std::pow(jacks[i]-mean, 2.0); } | ||||
|     return std::sqrt(RealD(N-1)/RealD(N)*std); | ||||
| } | ||||
|  | ||||
| std::vector<RealD> jack_stats(const std::vector<RealD>& data) | ||||
| { | ||||
|     int N = data.size(); | ||||
|     std::vector<RealD> jack_samples(N); | ||||
|     std::vector<RealD> jack_stats(2); | ||||
|  | ||||
|     jack_stats[0] = mean(data); | ||||
|     for(int i=0; i<N; i++){ jack_samples[i] = jack_mean(data,i); } | ||||
|     jack_stats[1] = jack_std(jack_samples, jack_stats[0]); | ||||
|     return jack_stats; | ||||
| } | ||||
|  | ||||
| int main(int argc, char **argv) | ||||
| { | ||||
|   Grid_init(&argc, &argv); | ||||
|  | ||||
|   // Initialize spacetime grid | ||||
|   std::cout << GridLogMessage << "Lattice dimensions: " | ||||
|     << grid_dim << "   Ls: " << Ls << std::endl; | ||||
|   GridCartesian* UGrid = SpaceTimeGrid::makeFourDimGrid(grid_dim, | ||||
|       GridDefaultSimd(Nd, vComplex::Nsimd()), GridDefaultMpi()); | ||||
|   GridRedBlackCartesian* UrbGrid = SpaceTimeGrid::makeFourDimRedBlackGrid(UGrid); | ||||
|   GridCartesian* FGrid = SpaceTimeGrid::makeFiveDimGrid(Ls, UGrid); | ||||
|   GridRedBlackCartesian* FrbGrid = SpaceTimeGrid::makeFiveDimRedBlackGrid(Ls, UGrid); | ||||
|  | ||||
|   // Set up RNGs | ||||
|   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); | ||||
|   RNG4.SeedFixedIntegers(seeds4); | ||||
|  | ||||
|   // Random gauge field | ||||
|   LatticeGaugeField Umu(UGrid); | ||||
|   SU3::HotConfiguration(RNG4, Umu); | ||||
|  | ||||
|   // Initialize RHMC fermion operators | ||||
|   MobiusFermionR Ddwf_f(Umu, *FGrid, *FrbGrid, *UGrid, *UrbGrid, mf, M5, b, c); | ||||
|   MobiusFermionR Ddwf_b(Umu, *FGrid, *FrbGrid, *UGrid, *UrbGrid, mb, M5, b, c); | ||||
|   SchurDiagMooeeOperator<MobiusFermionR, LatticeFermion> MdagM(Ddwf_f); | ||||
|   SchurDiagMooeeOperator<MobiusFermionR, LatticeFermion> VdagV(Ddwf_b); | ||||
|  | ||||
|   // Degree 12 rational approximations to x^(1/4) and x^(-1/4) | ||||
|   double     lo = 0.0001; | ||||
|   double     hi = 95.0; | ||||
|   int precision = 64; | ||||
|   int    degree = 12; | ||||
|   AlgRemez remez(lo, hi, precision); | ||||
|   std::cout << GridLogMessage << "Generating degree " << degree << " for x^(1/4)" << std::endl; | ||||
|   remez.generateApprox(degree, 1, 4); | ||||
|   MultiShiftFunction PowerQuarter(remez, stop_tol, false); | ||||
|   MultiShiftFunction PowerNegQuarter(remez, stop_tol, true); | ||||
|  | ||||
|   // Stochastically estimate reweighting factor via RHMC | ||||
|   RealD scale = std::sqrt(0.5); | ||||
|   std::vector<RealD> rw_rhmc(Nhits); | ||||
|   ConjugateGradientMultiShift<LatticeFermion> msCG_V(max_iter, PowerQuarter); | ||||
|   ConjugateGradientMultiShift<LatticeFermion> msCG_M(max_iter, PowerNegQuarter); | ||||
|   std::cout.precision(12); | ||||
|  | ||||
|   for(int hit=0; hit<Nhits; hit++){ | ||||
|  | ||||
|     // Gaussian source | ||||
|     LatticeFermion Phi    (Ddwf_f.FermionGrid()); | ||||
|     LatticeFermion PhiOdd (Ddwf_f.FermionRedBlackGrid()); | ||||
|     std::vector<LatticeFermion> tmp(2, Ddwf_f.FermionRedBlackGrid()); | ||||
|     gaussian(RNG5, Phi); | ||||
|     Phi = Phi*scale; | ||||
|  | ||||
|     pickCheckerboard(Odd, PhiOdd, Phi); | ||||
|  | ||||
|     // evaluate -log(rw) | ||||
|     msCG_V(VdagV, PhiOdd, tmp[0]); | ||||
|     msCG_M(MdagM, tmp[0], tmp[1]); | ||||
|     rw_rhmc[hit] = norm2(tmp[1]) - norm2(PhiOdd); | ||||
|     std::cout << std::endl << "==================================================" << std::endl; | ||||
|     std::cout << " --- RHMC: Hit " << hit << ": rw = " << rw_rhmc[hit]; | ||||
|     std::cout << std::endl << "==================================================" << std::endl << std::endl; | ||||
|  | ||||
|   } | ||||
|  | ||||
|   // Initialize EOFA fermion operators | ||||
|   RealD shift_L = 0.0; | ||||
|   RealD shift_R = -1.0; | ||||
|   int pm = 1; | ||||
|   MobiusEOFAFermionR Deofa_L(Umu, *FGrid, *FrbGrid, *UGrid, *UrbGrid, mf, mf, mb, shift_L, pm, M5, b, c); | ||||
|   MobiusEOFAFermionR Deofa_R(Umu, *FGrid, *FrbGrid, *UGrid, *UrbGrid, mb, mf, mb, shift_R, pm, M5, b, c); | ||||
|   MdagMLinearOperator<MobiusEOFAFermionR, LatticeFermion> LdagL(Deofa_L); | ||||
|   MdagMLinearOperator<MobiusEOFAFermionR, LatticeFermion> RdagR(Deofa_R); | ||||
|  | ||||
|   // Stochastically estimate reweighting factor via EOFA | ||||
|   RealD k = Deofa_L.k; | ||||
|   std::vector<RealD> rw_eofa(Nhits); | ||||
|   ConjugateGradient<LatticeFermion> CG(stop_tol, max_iter); | ||||
|   SchurRedBlackDiagMooeeSolve<LatticeFermion> SchurSolver(CG); | ||||
|  | ||||
|   // Compute -log(Z), where: ( RHMC det ratio ) = Z * ( EOFA det ratio ) | ||||
|   RealD Z = std::pow(b+c+1.0,Ls) + mf*std::pow(b+c-1.0,Ls); | ||||
|   Z /= std::pow(b+c+1.0,Ls) + mb*std::pow(b+c-1.0,Ls); | ||||
|   Z = -12.0*grid_dim[0]*grid_dim[1]*grid_dim[2]*grid_dim[3]*std::log(Z); | ||||
|  | ||||
|   for(int hit=0; hit<Nhits; hit++){ | ||||
|  | ||||
|     // Gaussian source | ||||
|     LatticeFermion Phi       (Deofa_L.FermionGrid()); | ||||
|     LatticeFermion spProj_Phi(Deofa_L.FermionGrid()); | ||||
|     std::vector<LatticeFermion> tmp(2, Deofa_L.FermionGrid()); | ||||
|     gaussian(RNG5, Phi); | ||||
|     Phi = Phi*scale; | ||||
|  | ||||
|     // evaluate -log(rw) | ||||
|     // LH term | ||||
|     for(int s=0; s<Ls; ++s){ axpby_ssp_pminus(spProj_Phi, 0.0, Phi, 1.0, Phi, s, s); } | ||||
|     Deofa_L.Omega(spProj_Phi, tmp[0], -1, 0); | ||||
|     G5R5(tmp[1], tmp[0]); | ||||
|     tmp[0] = zero; | ||||
|     SchurSolver(Deofa_L, tmp[1], tmp[0]); | ||||
|     Deofa_L.Dtilde(tmp[0], tmp[1]); | ||||
|     Deofa_L.Omega(tmp[1], tmp[0], -1, 1); | ||||
|     rw_eofa[hit] = Z - k*innerProduct(spProj_Phi,tmp[0]).real(); | ||||
|  | ||||
|     // RH term | ||||
|     for(int s=0; s<Ls; ++s){ axpby_ssp_pplus(spProj_Phi, 0.0, Phi, 1.0, Phi, s, s); } | ||||
|     Deofa_R.Omega(spProj_Phi, tmp[0], 1, 0); | ||||
|     G5R5(tmp[1], tmp[0]); | ||||
|     tmp[0] = zero; | ||||
|     SchurSolver(Deofa_R, tmp[1], tmp[0]); | ||||
|     Deofa_R.Dtilde(tmp[0], tmp[1]); | ||||
|     Deofa_R.Omega(tmp[1], tmp[0], 1, 1); | ||||
|     rw_eofa[hit] += k*innerProduct(spProj_Phi,tmp[0]).real(); | ||||
|     std::cout << std::endl << "==================================================" << std::endl; | ||||
|     std::cout << " --- EOFA: Hit " << hit << ": rw = " << rw_eofa[hit]; | ||||
|     std::cout << std::endl << "==================================================" << std::endl << std::endl; | ||||
|  | ||||
|   } | ||||
|  | ||||
|   std::vector<RealD> rhmc_result = jack_stats(rw_rhmc); | ||||
|   std::vector<RealD> eofa_result = jack_stats(rw_eofa); | ||||
|   std::cout << std::endl << "RHMC: rw = " << rhmc_result[0] << " +/- " << rhmc_result[1] << std::endl; | ||||
|   std::cout << std::endl << "EOFA: rw = " << eofa_result[0] << " +/- " << eofa_result[1] << std::endl; | ||||
|  | ||||
|   Grid_finalize(); | ||||
| } | ||||
							
								
								
									
										218
									
								
								tests/debug/Test_reweight_mobius_eofa_gparity.cc
									
									
									
									
									
										Normal file
									
								
							
							
						
						
									
										218
									
								
								tests/debug/Test_reweight_mobius_eofa_gparity.cc
									
									
									
									
									
										Normal file
									
								
							| @@ -0,0 +1,218 @@ | ||||
| /************************************************************************************* | ||||
|  | ||||
| Grid physics library, www.github.com/paboyle/Grid | ||||
|  | ||||
| Source file: ./tests/debug/Test_reweight_dwf_eofa.cc | ||||
|  | ||||
| Copyright (C) 2017 | ||||
|  | ||||
| Author: Peter Boyle <paboyle@ph.ed.ac.uk> | ||||
| Author: paboyle <paboyle@ph.ed.ac.uk> | ||||
| Author: David Murphy <dmurphy@phys.columbia.edu> | ||||
|  | ||||
| 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; | ||||
| using namespace Grid::QCD; | ||||
|  | ||||
| typedef typename GparityDomainWallFermionR::FermionField FermionField; | ||||
|  | ||||
| // parameters for test | ||||
| const std::vector<int> grid_dim = { 8, 8, 8, 8 }; | ||||
| const int Ls = 8; | ||||
| const int Nhits = 10; | ||||
| const int max_iter = 5000; | ||||
| const RealD b  = 2.5; | ||||
| const RealD c  = 1.5; | ||||
| const RealD mf = 0.1; | ||||
| const RealD mb = 0.11; | ||||
| const RealD M5 = 1.8; | ||||
| const RealD stop_tol = 1.0e-12; | ||||
|  | ||||
| RealD mean(const std::vector<RealD>& data) | ||||
| { | ||||
|     int N = data.size(); | ||||
|     RealD mean(0.0); | ||||
|     for(int i=0; i<N; ++i){ mean += data[i]; } | ||||
|     return mean/RealD(N); | ||||
| } | ||||
|  | ||||
| RealD jack_mean(const std::vector<RealD>& data, int sample) | ||||
| { | ||||
|     int N = data.size(); | ||||
|     RealD mean(0.0); | ||||
|     for(int i=0; i<N; ++i){ if(i != sample){ mean += data[i]; } } | ||||
|     return mean/RealD(N-1); | ||||
| } | ||||
|  | ||||
| RealD jack_std(const std::vector<RealD>& jacks, RealD mean) | ||||
| { | ||||
|     int N = jacks.size(); | ||||
|     RealD std(0.0); | ||||
|     for(int i=0; i<N; ++i){ std += std::pow(jacks[i]-mean, 2.0); } | ||||
|     return std::sqrt(RealD(N-1)/RealD(N)*std); | ||||
| } | ||||
|  | ||||
| std::vector<RealD> jack_stats(const std::vector<RealD>& data) | ||||
| { | ||||
|     int N = data.size(); | ||||
|     std::vector<RealD> jack_samples(N); | ||||
|     std::vector<RealD> jack_stats(2); | ||||
|  | ||||
|     jack_stats[0] = mean(data); | ||||
|     for(int i=0; i<N; i++){ jack_samples[i] = jack_mean(data,i); } | ||||
|     jack_stats[1] = jack_std(jack_samples, jack_stats[0]); | ||||
|     return jack_stats; | ||||
| } | ||||
|  | ||||
| int main(int argc, char **argv) | ||||
| { | ||||
|   Grid_init(&argc, &argv); | ||||
|  | ||||
|   // Initialize spacetime grid | ||||
|   std::cout << GridLogMessage << "Lattice dimensions: " | ||||
|     << grid_dim << "   Ls: " << Ls << std::endl; | ||||
|   GridCartesian* UGrid = SpaceTimeGrid::makeFourDimGrid(grid_dim, | ||||
|       GridDefaultSimd(Nd, vComplex::Nsimd()), GridDefaultMpi()); | ||||
|   GridRedBlackCartesian* UrbGrid = SpaceTimeGrid::makeFourDimRedBlackGrid(UGrid); | ||||
|   GridCartesian* FGrid = SpaceTimeGrid::makeFiveDimGrid(Ls, UGrid); | ||||
|   GridRedBlackCartesian* FrbGrid = SpaceTimeGrid::makeFiveDimRedBlackGrid(Ls, UGrid); | ||||
|  | ||||
|   // Set up RNGs | ||||
|   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); | ||||
|   RNG4.SeedFixedIntegers(seeds4); | ||||
|  | ||||
|   // Random gauge field | ||||
|   LatticeGaugeField Umu(UGrid); | ||||
|   SU3::HotConfiguration(RNG4, Umu); | ||||
|  | ||||
|   // Initialize RHMC fermion operators | ||||
|   GparityDomainWallFermionR::ImplParams params; | ||||
|   GparityMobiusFermionR Ddwf_f(Umu, *FGrid, *FrbGrid, *UGrid, *UrbGrid, mf, M5, b, c, params); | ||||
|   GparityMobiusFermionR Ddwf_b(Umu, *FGrid, *FrbGrid, *UGrid, *UrbGrid, mb, M5, b, c, params); | ||||
|   SchurDiagMooeeOperator<GparityMobiusFermionR, FermionField> MdagM(Ddwf_f); | ||||
|   SchurDiagMooeeOperator<GparityMobiusFermionR, FermionField> VdagV(Ddwf_b); | ||||
|  | ||||
|   // Degree 12 rational approximations to x^(1/4) and x^(-1/4) | ||||
|   double     lo = 0.0001; | ||||
|   double     hi = 95.0; | ||||
|   int precision = 64; | ||||
|   int    degree = 12; | ||||
|   AlgRemez remez(lo, hi, precision); | ||||
|   std::cout << GridLogMessage << "Generating degree " << degree << " for x^(1/4)" << std::endl; | ||||
|   remez.generateApprox(degree, 1, 4); | ||||
|   MultiShiftFunction PowerQuarter(remez, stop_tol, false); | ||||
|   MultiShiftFunction PowerNegQuarter(remez, stop_tol, true); | ||||
|  | ||||
|   // Stochastically estimate reweighting factor via RHMC | ||||
|   RealD scale = std::sqrt(0.5); | ||||
|   std::vector<RealD> rw_rhmc(Nhits); | ||||
|   ConjugateGradientMultiShift<FermionField> msCG_V(max_iter, PowerQuarter); | ||||
|   ConjugateGradientMultiShift<FermionField> msCG_M(max_iter, PowerNegQuarter); | ||||
|   std::cout.precision(12); | ||||
|  | ||||
|   for(int hit=0; hit<Nhits; hit++){ | ||||
|  | ||||
|     // Gaussian source | ||||
|     FermionField Phi    (Ddwf_f.FermionGrid()); | ||||
|     FermionField PhiOdd (Ddwf_f.FermionRedBlackGrid()); | ||||
|     std::vector<FermionField> tmp(2, Ddwf_f.FermionRedBlackGrid()); | ||||
|     gaussian(RNG5, Phi); | ||||
|     Phi = Phi*scale; | ||||
|  | ||||
|     pickCheckerboard(Odd, PhiOdd, Phi); | ||||
|  | ||||
|     // evaluate -log(rw) | ||||
|     msCG_V(VdagV, PhiOdd, tmp[0]); | ||||
|     msCG_M(MdagM, tmp[0], tmp[1]); | ||||
|     rw_rhmc[hit] = norm2(tmp[1]) - norm2(PhiOdd); | ||||
|     std::cout << std::endl << "==================================================" << std::endl; | ||||
|     std::cout << " --- RHMC: Hit " << hit << ": rw = " << rw_rhmc[hit]; | ||||
|     std::cout << std::endl << "==================================================" << std::endl << std::endl; | ||||
|  | ||||
|   } | ||||
|  | ||||
|   // Initialize EOFA fermion operators | ||||
|   RealD shift_L = 0.0; | ||||
|   RealD shift_R = -1.0; | ||||
|   int pm = 1; | ||||
|   GparityMobiusEOFAFermionR Deofa_L(Umu, *FGrid, *FrbGrid, *UGrid, *UrbGrid, mf, mf, mb, shift_L, pm, M5, b, c, params); | ||||
|   GparityMobiusEOFAFermionR Deofa_R(Umu, *FGrid, *FrbGrid, *UGrid, *UrbGrid, mb, mf, mb, shift_R, pm, M5, b, c, params); | ||||
|   MdagMLinearOperator<GparityMobiusEOFAFermionR, FermionField> LdagL(Deofa_L); | ||||
|   MdagMLinearOperator<GparityMobiusEOFAFermionR, FermionField> RdagR(Deofa_R); | ||||
|  | ||||
|   // Stochastically estimate reweighting factor via EOFA | ||||
|   RealD k = Deofa_L.k; | ||||
|   std::vector<RealD> rw_eofa(Nhits); | ||||
|   ConjugateGradient<FermionField> CG(stop_tol, max_iter); | ||||
|   SchurRedBlackDiagMooeeSolve<FermionField> SchurSolver(CG); | ||||
|  | ||||
|   // Compute -log(Z), where: ( RHMC det ratio ) = Z * ( EOFA det ratio ) | ||||
|   RealD Z = std::pow(b+c+1.0,Ls) + mf*std::pow(b+c-1.0,Ls); | ||||
|   Z /= std::pow(b+c+1.0,Ls) + mb*std::pow(b+c-1.0,Ls); | ||||
|   Z = -12.0*grid_dim[0]*grid_dim[1]*grid_dim[2]*grid_dim[3]*std::log(Z); | ||||
|  | ||||
|   for(int hit=0; hit<Nhits; hit++){ | ||||
|  | ||||
|     // Gaussian source | ||||
|     FermionField Phi       (Deofa_L.FermionGrid()); | ||||
|     FermionField spProj_Phi(Deofa_L.FermionGrid()); | ||||
|     std::vector<FermionField> tmp(2, Deofa_L.FermionGrid()); | ||||
|     gaussian(RNG5, Phi); | ||||
|     Phi = Phi*scale; | ||||
|  | ||||
|     // evaluate -log(rw) | ||||
|     // LH term | ||||
|     for(int s=0; s<Ls; ++s){ axpby_ssp_pminus(spProj_Phi, 0.0, Phi, 1.0, Phi, s, s); } | ||||
|     Deofa_L.Omega(spProj_Phi, tmp[0], -1, 0); | ||||
|     G5R5(tmp[1], tmp[0]); | ||||
|     tmp[0] = zero; | ||||
|     SchurSolver(Deofa_L, tmp[1], tmp[0]); | ||||
|     Deofa_L.Dtilde(tmp[0], tmp[1]); | ||||
|     Deofa_L.Omega(tmp[1], tmp[0], -1, 1); | ||||
|     rw_eofa[hit] = 2.0*Z - k*innerProduct(spProj_Phi,tmp[0]).real(); | ||||
|  | ||||
|     // RH term | ||||
|     for(int s=0; s<Ls; ++s){ axpby_ssp_pplus(spProj_Phi, 0.0, Phi, 1.0, Phi, s, s); } | ||||
|     Deofa_R.Omega(spProj_Phi, tmp[0], 1, 0); | ||||
|     G5R5(tmp[1], tmp[0]); | ||||
|     tmp[0] = zero; | ||||
|     SchurSolver(Deofa_R, tmp[1], tmp[0]); | ||||
|     Deofa_R.Dtilde(tmp[0], tmp[1]); | ||||
|     Deofa_R.Omega(tmp[1], tmp[0], 1, 1); | ||||
|     rw_eofa[hit] += k*innerProduct(spProj_Phi,tmp[0]).real(); | ||||
|     std::cout << std::endl << "==================================================" << std::endl; | ||||
|     std::cout << " --- EOFA: Hit " << hit << ": rw = " << rw_eofa[hit]; | ||||
|     std::cout << std::endl << "==================================================" << std::endl << std::endl; | ||||
|  | ||||
|   } | ||||
|  | ||||
|   std::vector<RealD> rhmc_result = jack_stats(rw_rhmc); | ||||
|   std::vector<RealD> eofa_result = jack_stats(rw_eofa); | ||||
|   std::cout << std::endl << "RHMC: rw = " << rhmc_result[0] << " +/- " << rhmc_result[1] << std::endl; | ||||
|   std::cout << std::endl << "EOFA: rw = " << eofa_result[0] << " +/- " << eofa_result[1] << std::endl; | ||||
|  | ||||
|   Grid_finalize(); | ||||
| } | ||||
| @@ -71,9 +71,9 @@ int main (int argc, char** argv) | ||||
|   int threads = GridThread::GetThreads(); | ||||
|   std::cout << GridLogMessage << "Grid is setup to use " << threads << " threads" << std::endl; | ||||
|  | ||||
|   LatticeFermion phi        (FGrid);  gaussian(RNG5, phi); | ||||
|   LatticeFermion Mphi       (FGrid); | ||||
|   LatticeFermion MphiPrime  (FGrid); | ||||
|   FermionField phi        (FGrid);  gaussian(RNG5, phi); | ||||
|   FermionField Mphi       (FGrid); | ||||
|   FermionField MphiPrime  (FGrid); | ||||
|  | ||||
|   LatticeGaugeField U(UGrid); | ||||
|   SU3::HotConfiguration(RNG4,U); | ||||
|   | ||||
							
								
								
									
										166
									
								
								tests/forces/Test_mobius_force_eofa.cc
									
									
									
									
									
										Normal file
									
								
							
							
						
						
									
										166
									
								
								tests/forces/Test_mobius_force_eofa.cc
									
									
									
									
									
										Normal file
									
								
							| @@ -0,0 +1,166 @@ | ||||
| /************************************************************************************* | ||||
|  | ||||
| Grid physics library, www.github.com/paboyle/Grid | ||||
|  | ||||
| Source file: ./tests/forces/Test_dwf_force_eofa.cc | ||||
|  | ||||
| Copyright (C) 2017 | ||||
|  | ||||
| Author: Peter Boyle <paboyle@ph.ed.ac.uk> | ||||
| Author: David Murphy <dmurphy@phys.columbia.edu> | ||||
|  | ||||
| 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; | ||||
| using namespace Grid::QCD; | ||||
|  | ||||
| int main (int argc, char** argv) | ||||
| { | ||||
|   Grid_init(&argc, &argv); | ||||
|  | ||||
|   std::vector<int> latt_size   = GridDefaultLatt(); | ||||
|   std::vector<int> simd_layout = GridDefaultSimd(Nd,vComplex::Nsimd()); | ||||
|   std::vector<int> mpi_layout  = GridDefaultMpi(); | ||||
|  | ||||
|   const int Ls = 8; | ||||
|  | ||||
|   GridCartesian         *UGrid   = SpaceTimeGrid::makeFourDimGrid(GridDefaultLatt(), GridDefaultSimd(Nd,vComplex::Nsimd()), GridDefaultMpi()); | ||||
|   GridRedBlackCartesian *UrbGrid = SpaceTimeGrid::makeFourDimRedBlackGrid(UGrid); | ||||
|   GridCartesian         *FGrid   = SpaceTimeGrid::makeFiveDimGrid(Ls, UGrid); | ||||
|   GridRedBlackCartesian *FrbGrid = SpaceTimeGrid::makeFiveDimRedBlackGrid(Ls, UGrid); | ||||
|  | ||||
|   // Want a different conf at every run | ||||
|   // First create an instance of an engine. | ||||
|   std::random_device rnd_device; | ||||
|   // Specify the engine and distribution. | ||||
|   std::mt19937 mersenne_engine(rnd_device()); | ||||
|   std::uniform_int_distribution<int> dist(1, 100); | ||||
|  | ||||
|   auto gen = std::bind(dist, mersenne_engine); | ||||
|   std::vector<int> seeds4(4); | ||||
|   generate(begin(seeds4), end(seeds4), gen); | ||||
|  | ||||
|   //std::vector<int> seeds4({1,2,3,5}); | ||||
|   std::vector<int> seeds5({5,6,7,8}); | ||||
|   GridParallelRNG RNG5(FGrid);  RNG5.SeedFixedIntegers(seeds5); | ||||
|   GridParallelRNG RNG4(UGrid);  RNG4.SeedFixedIntegers(seeds4); | ||||
|  | ||||
|   int threads = GridThread::GetThreads(); | ||||
|   std::cout << GridLogMessage << "Grid is setup to use " << threads << " threads" << std::endl; | ||||
|  | ||||
|   LatticeFermion phi        (FGrid);  gaussian(RNG5, phi); | ||||
|   LatticeFermion Mphi       (FGrid); | ||||
|   LatticeFermion MphiPrime  (FGrid); | ||||
|  | ||||
|   LatticeGaugeField U(UGrid); | ||||
|   SU3::HotConfiguration(RNG4,U); | ||||
|  | ||||
|   //////////////////////////////////// | ||||
|   // Unmodified matrix element | ||||
|   //////////////////////////////////// | ||||
|   RealD b  = 2.5; | ||||
|   RealD c  = 1.5; | ||||
|   RealD mf = 0.01; | ||||
|   RealD mb = 1.0; | ||||
|   RealD M5 = 1.8; | ||||
|   MobiusEOFAFermionR Lop(U, *FGrid, *FrbGrid, *UGrid, *UrbGrid, mf, mf, mb, 0.0, -1, M5, b, c); | ||||
|   MobiusEOFAFermionR Rop(U, *FGrid, *FrbGrid, *UGrid, *UrbGrid, mb, mf, mb, -1.0, 1, M5, b, c); | ||||
|   OneFlavourRationalParams Params(0.95, 100.0, 5000, 1.0e-12, 12); | ||||
|   ConjugateGradient<LatticeFermion> CG(1.0e-12, 5000); | ||||
|   ExactOneFlavourRatioPseudoFermionAction<WilsonImplR> Meofa(Lop, Rop, CG, Params, false); | ||||
|  | ||||
|   Meofa.refresh(U, RNG5); | ||||
|   RealD S = Meofa.S(U); // pdag M p | ||||
|  | ||||
|   // get the deriv of phidag M phi with respect to "U" | ||||
|   LatticeGaugeField UdSdU(UGrid); | ||||
|   Meofa.deriv(U, UdSdU); | ||||
|  | ||||
|   //////////////////////////////////// | ||||
|   // Modify the gauge field a little | ||||
|   //////////////////////////////////// | ||||
|   RealD dt = 0.0001; | ||||
|  | ||||
|   LatticeColourMatrix mommu(UGrid); | ||||
|   LatticeColourMatrix forcemu(UGrid); | ||||
|   LatticeGaugeField mom(UGrid); | ||||
|   LatticeGaugeField Uprime(UGrid); | ||||
|  | ||||
|   for(int mu=0; mu<Nd; mu++){ | ||||
|  | ||||
|     SU3::GaussianFundamentalLieAlgebraMatrix(RNG4, mommu); // Traceless antihermitian momentum; gaussian in lie alg | ||||
|  | ||||
|     PokeIndex<LorentzIndex>(mom, mommu, mu); | ||||
|  | ||||
|     // fourth order exponential approx | ||||
|     parallel_for(auto i=mom.begin(); i<mom.end(); i++){ | ||||
|       Uprime[i](mu) = U[i](mu) + mom[i](mu)*U[i](mu)*dt + mom[i](mu) *mom[i](mu) *U[i](mu)*(dt*dt/2.0) | ||||
|                         + mom[i](mu) *mom[i](mu) *mom[i](mu) *U[i](mu)*(dt*dt*dt/6.0) | ||||
|                         + mom[i](mu) *mom[i](mu) *mom[i](mu) *mom[i](mu) *U[i](mu)*(dt*dt*dt*dt/24.0) | ||||
|                         + mom[i](mu) *mom[i](mu) *mom[i](mu) *mom[i](mu) *mom[i](mu) *U[i](mu)*(dt*dt*dt*dt*dt/120.0) | ||||
|                         + mom[i](mu) *mom[i](mu) *mom[i](mu) *mom[i](mu) *mom[i](mu) *mom[i](mu) *U[i](mu)*(dt*dt*dt*dt*dt*dt/720.0); | ||||
|     } | ||||
|   } | ||||
|  | ||||
|   /*Ddwf.ImportGauge(Uprime); | ||||
|   Ddwf.M          (phi,MphiPrime); | ||||
|  | ||||
|   ComplexD Sprime    = innerProduct(MphiPrime   ,MphiPrime);*/ | ||||
|   RealD Sprime = Meofa.S(Uprime); | ||||
|  | ||||
|   ////////////////////////////////////////////// | ||||
|   // Use derivative to estimate dS | ||||
|   ////////////////////////////////////////////// | ||||
|  | ||||
|   LatticeComplex dS(UGrid); | ||||
|   dS = zero; | ||||
|   for(int mu=0; mu<Nd; mu++){ | ||||
|     mommu = PeekIndex<LorentzIndex>(UdSdU, mu); | ||||
|     mommu = Ta(mommu)*2.0; | ||||
|     PokeIndex<LorentzIndex>(UdSdU, mommu, mu); | ||||
|   } | ||||
|  | ||||
|   for(int mu=0; mu<Nd; mu++){ | ||||
|     forcemu = PeekIndex<LorentzIndex>(UdSdU, mu); | ||||
|     mommu   = PeekIndex<LorentzIndex>(mom, mu); | ||||
|  | ||||
|     // Update PF action density | ||||
|     dS = dS + trace(mommu*forcemu)*dt; | ||||
|   } | ||||
|  | ||||
|   ComplexD dSpred = sum(dS); | ||||
|  | ||||
|   /*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;*/ | ||||
|   printf("\nS = %1.15e\n", S); | ||||
|   printf("Sprime = %1.15e\n", Sprime); | ||||
|   printf("dS = %1.15e\n", Sprime - S); | ||||
|   printf("real(dS_predict) = %1.15e\n", dSpred.real()); | ||||
|   printf("imag(dS_predict) = %1.15e\n\n", dSpred.imag()); | ||||
|  | ||||
|   assert( fabs(real(Sprime-S-dSpred)) < 1.0 ) ; | ||||
|  | ||||
|   std::cout << GridLogMessage << "Done" << std::endl; | ||||
|   Grid_finalize(); | ||||
| } | ||||
							
								
								
									
										171
									
								
								tests/forces/Test_mobius_gpforce_eofa.cc
									
									
									
									
									
										Normal file
									
								
							
							
						
						
									
										171
									
								
								tests/forces/Test_mobius_gpforce_eofa.cc
									
									
									
									
									
										Normal file
									
								
							| @@ -0,0 +1,171 @@ | ||||
| /************************************************************************************* | ||||
|  | ||||
| Grid physics library, www.github.com/paboyle/Grid | ||||
|  | ||||
| Source file: ./tests/forces/Test_dwf_force_eofa.cc | ||||
|  | ||||
| Copyright (C) 2017 | ||||
|  | ||||
| Author: Peter Boyle <paboyle@ph.ed.ac.uk> | ||||
| Author: David Murphy <dmurphy@phys.columbia.edu> | ||||
|  | ||||
| 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; | ||||
| using namespace Grid::QCD; | ||||
|  | ||||
| typedef GparityWilsonImplR FermionImplPolicy; | ||||
| typedef GparityMobiusEOFAFermionR FermionAction; | ||||
| typedef typename FermionAction::FermionField FermionField; | ||||
|  | ||||
| int main (int argc, char** argv) | ||||
| { | ||||
|   Grid_init(&argc, &argv); | ||||
|  | ||||
|   std::vector<int> latt_size   = GridDefaultLatt(); | ||||
|   std::vector<int> simd_layout = GridDefaultSimd(Nd,vComplex::Nsimd()); | ||||
|   std::vector<int> mpi_layout  = GridDefaultMpi(); | ||||
|  | ||||
|   const int Ls = 8; | ||||
|  | ||||
|   GridCartesian         *UGrid   = SpaceTimeGrid::makeFourDimGrid(GridDefaultLatt(), GridDefaultSimd(Nd,vComplex::Nsimd()), GridDefaultMpi()); | ||||
|   GridRedBlackCartesian *UrbGrid = SpaceTimeGrid::makeFourDimRedBlackGrid(UGrid); | ||||
|   GridCartesian         *FGrid   = SpaceTimeGrid::makeFiveDimGrid(Ls, UGrid); | ||||
|   GridRedBlackCartesian *FrbGrid = SpaceTimeGrid::makeFiveDimRedBlackGrid(Ls, UGrid); | ||||
|  | ||||
|   // Want a different conf at every run | ||||
|   // First create an instance of an engine. | ||||
|   std::random_device rnd_device; | ||||
|   // Specify the engine and distribution. | ||||
|   std::mt19937 mersenne_engine(rnd_device()); | ||||
|   std::uniform_int_distribution<int> dist(1, 100); | ||||
|  | ||||
|   auto gen = std::bind(dist, mersenne_engine); | ||||
|   std::vector<int> seeds4(4); | ||||
|   generate(begin(seeds4), end(seeds4), gen); | ||||
|  | ||||
|   //std::vector<int> seeds4({1,2,3,5}); | ||||
|   std::vector<int> seeds5({5,6,7,8}); | ||||
|   GridParallelRNG RNG5(FGrid);  RNG5.SeedFixedIntegers(seeds5); | ||||
|   GridParallelRNG RNG4(UGrid);  RNG4.SeedFixedIntegers(seeds4); | ||||
|  | ||||
|   int threads = GridThread::GetThreads(); | ||||
|   std::cout << GridLogMessage << "Grid is setup to use " << threads << " threads" << std::endl; | ||||
|  | ||||
|   FermionField phi        (FGrid);  gaussian(RNG5, phi); | ||||
|   FermionField Mphi       (FGrid); | ||||
|   FermionField MphiPrime  (FGrid); | ||||
|  | ||||
|   LatticeGaugeField U(UGrid); | ||||
|   SU3::HotConfiguration(RNG4,U); | ||||
|  | ||||
|   //////////////////////////////////// | ||||
|   // Unmodified matrix element | ||||
|   //////////////////////////////////// | ||||
|   RealD b  = 2.5; | ||||
|   RealD c  = 1.5; | ||||
|   RealD mf = 0.01; | ||||
|   RealD mb = 1.0; | ||||
|   RealD M5 = 1.8; | ||||
|   FermionAction::ImplParams params; | ||||
|   FermionAction Lop(U, *FGrid, *FrbGrid, *UGrid, *UrbGrid, mf, mf, mb, 0.0, -1, M5, b, c, params); | ||||
|   FermionAction Rop(U, *FGrid, *FrbGrid, *UGrid, *UrbGrid, mb, mf, mb, -1.0, 1, M5, b, c, params); | ||||
|   OneFlavourRationalParams Params(0.95, 100.0, 5000, 1.0e-12, 12); | ||||
|   ConjugateGradient<FermionField> CG(1.0e-12, 5000); | ||||
|   ExactOneFlavourRatioPseudoFermionAction<FermionImplPolicy> Meofa(Lop, Rop, CG, Params, false); | ||||
|  | ||||
|   Meofa.refresh(U, RNG5); | ||||
|   RealD S = Meofa.S(U); // pdag M p | ||||
|  | ||||
|   // get the deriv of phidag M phi with respect to "U" | ||||
|   LatticeGaugeField UdSdU(UGrid); | ||||
|   Meofa.deriv(U, UdSdU); | ||||
|  | ||||
|   //////////////////////////////////// | ||||
|   // Modify the gauge field a little | ||||
|   //////////////////////////////////// | ||||
|   RealD dt = 0.0001; | ||||
|  | ||||
|   LatticeColourMatrix mommu(UGrid); | ||||
|   LatticeColourMatrix forcemu(UGrid); | ||||
|   LatticeGaugeField mom(UGrid); | ||||
|   LatticeGaugeField Uprime(UGrid); | ||||
|  | ||||
|   for(int mu=0; mu<Nd; mu++){ | ||||
|  | ||||
|     SU3::GaussianFundamentalLieAlgebraMatrix(RNG4, mommu); // Traceless antihermitian momentum; gaussian in lie alg | ||||
|  | ||||
|     PokeIndex<LorentzIndex>(mom, mommu, mu); | ||||
|  | ||||
|     // fourth order exponential approx | ||||
|     parallel_for(auto i=mom.begin(); i<mom.end(); i++){ | ||||
|       Uprime[i](mu) = U[i](mu) + mom[i](mu)*U[i](mu)*dt + mom[i](mu) *mom[i](mu) *U[i](mu)*(dt*dt/2.0) | ||||
|                         + mom[i](mu) *mom[i](mu) *mom[i](mu) *U[i](mu)*(dt*dt*dt/6.0) | ||||
|                         + mom[i](mu) *mom[i](mu) *mom[i](mu) *mom[i](mu) *U[i](mu)*(dt*dt*dt*dt/24.0) | ||||
|                         + mom[i](mu) *mom[i](mu) *mom[i](mu) *mom[i](mu) *mom[i](mu) *U[i](mu)*(dt*dt*dt*dt*dt/120.0) | ||||
|                         + mom[i](mu) *mom[i](mu) *mom[i](mu) *mom[i](mu) *mom[i](mu) *mom[i](mu) *U[i](mu)*(dt*dt*dt*dt*dt*dt/720.0); | ||||
|     } | ||||
|   } | ||||
|  | ||||
|   /*Ddwf.ImportGauge(Uprime); | ||||
|   Ddwf.M          (phi,MphiPrime); | ||||
|  | ||||
|   ComplexD Sprime    = innerProduct(MphiPrime   ,MphiPrime);*/ | ||||
|   RealD Sprime = Meofa.S(Uprime); | ||||
|  | ||||
|   ////////////////////////////////////////////// | ||||
|   // Use derivative to estimate dS | ||||
|   ////////////////////////////////////////////// | ||||
|  | ||||
|   LatticeComplex dS(UGrid); | ||||
|   dS = zero; | ||||
|   for(int mu=0; mu<Nd; mu++){ | ||||
|     mommu = PeekIndex<LorentzIndex>(UdSdU, mu); | ||||
|     mommu = Ta(mommu)*2.0; | ||||
|     PokeIndex<LorentzIndex>(UdSdU, mommu, mu); | ||||
|   } | ||||
|  | ||||
|   for(int mu=0; mu<Nd; mu++){ | ||||
|     forcemu = PeekIndex<LorentzIndex>(UdSdU, mu); | ||||
|     mommu   = PeekIndex<LorentzIndex>(mom, mu); | ||||
|  | ||||
|     // Update PF action density | ||||
|     dS = dS + trace(mommu*forcemu)*dt; | ||||
|   } | ||||
|  | ||||
|   ComplexD dSpred = sum(dS); | ||||
|  | ||||
|   /*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;*/ | ||||
|   printf("\nS = %1.15e\n", S); | ||||
|   printf("Sprime = %1.15e\n", Sprime); | ||||
|   printf("dS = %1.15e\n", Sprime - S); | ||||
|   printf("real(dS_predict) = %1.15e\n", dSpred.real()); | ||||
|   printf("imag(dS_predict) = %1.15e\n\n", dSpred.imag()); | ||||
|  | ||||
|   assert( fabs(real(Sprime-S-dSpred)) < 1.0 ) ; | ||||
|  | ||||
|   std::cout << GridLogMessage << "Done" << std::endl; | ||||
|   Grid_finalize(); | ||||
| } | ||||
		Reference in New Issue
	
	Block a user