From 0fa66e8f3ca4d7321224d2246d29acf3919b0c4e Mon Sep 17 00:00:00 2001 From: Guido Cossu Date: Mon, 4 Jul 2016 15:35:37 +0100 Subject: [PATCH] Debugged smearing for EOWilson, accepts --- lib/qcd/hmc/integrators/Integrator.h | 238 +++++++++++++------------- lib/qcd/smearing/APEsmearing.h | 121 +++++++------ lib/qcd/smearing/GaugeConfiguration.h | 163 +++++++++--------- lib/qcd/smearing/StoutSmearing.h | 183 +++++--------------- 4 files changed, 305 insertions(+), 400 deletions(-) diff --git a/lib/qcd/hmc/integrators/Integrator.h b/lib/qcd/hmc/integrators/Integrator.h index 58e1f585..db61b114 100644 --- a/lib/qcd/hmc/integrators/Integrator.h +++ b/lib/qcd/hmc/integrators/Integrator.h @@ -44,40 +44,40 @@ Author: paboyle #include -namespace Grid{ - namespace QCD{ + namespace Grid{ + namespace QCD{ - struct IntegratorParameters{ + struct IntegratorParameters{ - int Nexp; + int Nexp; int MDsteps; // number of outer steps RealD trajL; // trajectory length RealD stepsize; IntegratorParameters(int MDsteps_, - RealD trajL_=1.0, - int Nexp_=12): - Nexp(Nexp_), - MDsteps(MDsteps_), - trajL(trajL_), - stepsize(trajL/MDsteps) - { + RealD trajL_=1.0, + int Nexp_=12): + Nexp(Nexp_), + MDsteps(MDsteps_), + trajL(trajL_), + stepsize(trajL/MDsteps) + { // empty body constructor - }; + }; - }; + }; /*! @brief Class for Molecular Dynamics management */ template - class Integrator { + class Integrator { - protected: + protected: - typedef IntegratorParameters ParameterType; + typedef IntegratorParameters ParameterType; - IntegratorParameters Params; + IntegratorParameters Params; - const ActionSet as; + const ActionSet as; int levels; // double t_U; // Track time passing on each level and for U and for P @@ -90,14 +90,14 @@ namespace Grid{ // Should match any legal (SU(n)) gauge field // Need to use this template to match Ncol to pass to SU class template void generate_momenta(Lattice< iVector< iScalar< iMatrix >, Nd> > & P,GridParallelRNG& pRNG){ - typedef Lattice< iScalar< iScalar< iMatrix > > > GaugeLinkField; - GaugeLinkField Pmu(P._grid); - Pmu = zero; - for(int mu=0;mu::GaussianLieAlgebraMatrix(pRNG, Pmu); - PokeIndex(P, Pmu, mu); - } + typedef Lattice< iScalar< iScalar< iMatrix > > > GaugeLinkField; + GaugeLinkField Pmu(P._grid); + Pmu = zero; + for(int mu=0;mu::GaussianLieAlgebraMatrix(pRNG, Pmu); + PokeIndex(P, Pmu, mu); } + } //ObserverList observers; // not yet @@ -105,126 +105,128 @@ namespace Grid{ // void register_observers(); // void notify_observers(); - void update_P(GaugeField&U, int level,double ep){ - t_P[level]+=ep; - update_P(P,U,level,ep); + void update_P(GaugeField&U, int level, double ep){ + t_P[level]+=ep; + update_P(P,U,level,ep); - std::cout<is_smeared); - as[level].actions.at(a)->deriv(Us,force); // deriv should not include Ta - std::cout<< GridLogIntegrator << "Smearing (on/off): "<is_smeared <is_smeared) Smearer.smeared_force(force); - force = Ta(force); - std::cout<< GridLogIntegrator << "Force average: "<< norm2(force)/(U._grid->gSites()) <is_smeared); + as[level].actions.at(a)->deriv(Us,force); // deriv should NOT include Ta + + std::cout<< GridLogIntegrator << "Smearing (on/off): "<is_smeared <is_smeared) Smearer.smeared_force(force); + force = Ta(force); + std::cout<< GridLogIntegrator << "Force average: "<< norm2(force)/(U._grid->gSites()) <(U, mu); - auto Pmu=PeekIndex(Mom, mu); - Umu = expMat(Pmu, ep, Params.Nexp)*Umu; - ProjectOnGroup(Umu); - PokeIndex(U, Umu, mu); - } + for (int mu = 0; mu < Nd; mu++){ + auto Umu=PeekIndex(U, mu); + auto Pmu=PeekIndex(Mom, mu); + Umu = expMat(Pmu, ep, Params.Nexp)*Umu; + ProjectOnGroup(Umu); + PokeIndex(U, Umu, mu); + } // Update the smeared fields, can be implemented as observer - Smearer.set_GaugeField(U); - } - - virtual void step (GaugeField& U,int level, int first,int last)=0; + Smearer.set_GaugeField(U); + } - public: + virtual void step (GaugeField& U,int level, int first,int last)=0; - Integrator(GridBase* grid, - IntegratorParameters Par, - ActionSet & Aset, - SmearingPolicy &Sm): - Params(Par), - as(Aset), - P(grid), - levels(Aset.size()), - Smearer(Sm) - { - t_P.resize(levels,0.0); - t_U=0.0; +public: + + Integrator(GridBase* grid, + IntegratorParameters Par, + ActionSet & Aset, + SmearingPolicy &Sm): + Params(Par), + as(Aset), + P(grid), + levels(Aset.size()), + Smearer(Sm) + { + t_P.resize(levels,0.0); + t_U=0.0; // initialization of smearer delegated outside of Integrator - }; - - virtual ~Integrator(){} + }; + + virtual ~Integrator(){} //Initialization of momenta and actions - void refresh(GaugeField& U,GridParallelRNG &pRNG){ - std::cout<is_smeared); - as[level].actions.at(actionID)->refresh(Us, pRNG); - } + GaugeField& Us = Smearer.get_U(as[level].actions.at(actionID)->is_smeared); + as[level].actions.at(actionID)->refresh(Us, pRNG); + } + } } - } // Calculate action - RealD S(GaugeField& U){ + RealD S(GaugeField& U){// here also U not used - LatticeComplex Hloc(U._grid); Hloc = zero; + LatticeComplex Hloc(U._grid); Hloc = zero; // Momenta - for (int mu=0; mu (P, mu); - Hloc -= trace(Pmu*Pmu); - } - Complex Hsum = sum(Hloc); - - RealD H = Hsum.real(); - RealD Hterm; - std::cout<(P, mu); + Hloc -= trace(Pmu*Pmu); + } + Complex Hsum = sum(Hloc); + + RealD H = Hsum.real(); + RealD Hterm; + std::cout<is_smeared); - Hterm = as[level].actions.at(actionID)->S(Us); - std::cout<& Stout): - smearingLevels(Nsmear), - StoutSmearing(Stout), - ThinLinks(NULL){ - for (unsigned int i=0; i< smearingLevels; ++i) - SmearedSet.push_back(*(new GaugeField(UGrid))); - } - + SmearedConfiguration(GridCartesian * UGrid, + unsigned int Nsmear, + Smear_Stout& Stout): + smearingLevels(Nsmear), + StoutSmearing(Stout), + ThinLinks(NULL){ + for (unsigned int i=0; i< smearingLevels; ++i) + SmearedSet.push_back(*(new GaugeField(UGrid))); + } + /*! For just thin links */ - SmearedConfiguration(): - smearingLevels(0), - StoutSmearing(), - SmearedSet(), - ThinLinks(NULL){} - - + SmearedConfiguration(): + smearingLevels(0), + StoutSmearing(), + SmearedSet(), + ThinLinks(NULL){} + + // attach the smeared routines to the thin links U and fill the smeared set - void set_GaugeField(GaugeField& U){ fill_smearedSet(U);} - - //==================================================================== - void smeared_force(GaugeField& SigmaTilde) const{ - if (smearingLevels > 0){ - GaugeField force = SigmaTilde;//actually = U*SigmaTilde - GaugeLinkField tmp_mu(SigmaTilde._grid); - - for (int mu = 0; mu < Nd; mu++){ - // to get SigmaTilde - tmp_mu = adj(peekLorentz(SmearedSet[smearingLevels-1], mu)) * peekLorentz(force,mu); - pokeLorentz(force, tmp_mu, mu); - } - for(int ismr = smearingLevels - 1; ismr > 0; --ismr) - force = AnalyticSmearedForce(force,get_smeared_conf(ismr-1)); - - force = AnalyticSmearedForce(force,*ThinLinks); - - for (int mu = 0; mu < Nd; mu++){ - tmp_mu = peekLorentz(*ThinLinks, mu) * peekLorentz(force, mu); - pokeLorentz(SigmaTilde, tmp_mu, mu); - } + void set_GaugeField(GaugeField& U){ fill_smearedSet(U);} + +//==================================================================== + void smeared_force(GaugeField& SigmaTilde) const{ + + if (smearingLevels > 0){ + GaugeField force(SigmaTilde._grid); + GaugeLinkField tmp_mu(SigmaTilde._grid); + force = SigmaTilde;//actually = U*SigmaTilde + + for (int mu = 0; mu < Nd; mu++){ + // to get just SigmaTilde + tmp_mu = adj(peekLorentz(SmearedSet[smearingLevels-1], mu)) * peekLorentz(force,mu); + pokeLorentz(force, tmp_mu, mu); + } + + for(int ismr = smearingLevels - 1; ismr > 0; --ismr) + force = AnalyticSmearedForce(force,get_smeared_conf(ismr-1)); + + force = AnalyticSmearedForce(force,*ThinLinks); + + for (int mu = 0; mu < Nd; mu++){ + tmp_mu = peekLorentz(*ThinLinks, mu) * peekLorentz(force, mu); + pokeLorentz(SigmaTilde, tmp_mu, mu); + } }// if smearingLevels = 0 do nothing } //==================================================================== @@ -246,7 +251,7 @@ GaugeField& get_U(bool smeared=false) { if (smeared){ if (smearingLevels){ RealD impl_plaq = WilsonLoops::avgPlaquette(SmearedSet[smearingLevels-1]); - std::cout<< GridLogDebug << "getting U Plaq: " << impl_plaq<< std::endl; + std::cout<< GridLogDebug << "getting Usmr Plaq: " << impl_plaq<< std::endl; return get_SmearedU(); } diff --git a/lib/qcd/smearing/StoutSmearing.h b/lib/qcd/smearing/StoutSmearing.h index 3c323c47..511a5c29 100644 --- a/lib/qcd/smearing/StoutSmearing.h +++ b/lib/qcd/smearing/StoutSmearing.h @@ -12,7 +12,6 @@ template class Smear_Stout: public Smear { private: - const std::vector d_rho; const Smear < Gimpl > * SmearBase; public: @@ -22,58 +21,48 @@ static_assert(Nc==3, "Stout smearing currently implemented only for Nc==3"); } - /*! Default constructor */ + /*! Default constructor */ Smear_Stout(double rho = 1.0):SmearBase(new Smear_APE < Gimpl > (rho)){ static_assert(Nc==3, "Stout smearing currently implemented only for Nc==3"); } - ~Smear_Stout(){} + ~Smear_Stout(){} //delete SmearBase... void smear(GaugeField& u_smr,const GaugeField& U) const{ - - GaugeField C(U._grid); GaugeLinkField tmp(U._grid), iq_mu(U._grid), Umu(U._grid); std::cout<< GridLogDebug << "Stout smearing started\n"; - //Smear the configurations + //Smear the configurations SmearBase->smear(C, U); + for (int mu = 0; muderivative(SigmaTerm, iLambda, Gauge); + }; - void derivative(GaugeField& SigmaTerm, - const GaugeField& iLambda, - const GaugeField& Gauge) const{ - SmearBase->derivative(SigmaTerm, iLambda, Gauge); - }; + void BaseSmear(GaugeField& C, + const GaugeField& U) const{ + SmearBase->smear(C, U); + }; - - void BaseSmear(GaugeField& C, - const GaugeField& U) const{ - SmearBase->smear(C, U); - }; - - void exponentiate_iQ(GaugeLinkField& e_iQ, - const GaugeLinkField& iQ) const{ + void exponentiate_iQ(GaugeLinkField& e_iQ, + const GaugeLinkField& iQ) const{ // Put this outside // only valid for SU(3) matrices @@ -84,124 +73,48 @@ // the i sign is coming from outside // input matrix is anti-hermitian NOT hermitian - GridBase *grid = iQ._grid; - GaugeLinkField unity(grid); - unity=1.0; + GridBase *grid = iQ._grid; + GaugeLinkField unity(grid); + unity=1.0; - GaugeLinkField iQ2(grid), iQ3(grid); - LatticeComplex u(grid), w(grid); - LatticeComplex f0(grid), f1(grid), f2(grid); + GaugeLinkField iQ2(grid), iQ3(grid); + LatticeComplex u(grid), w(grid); + LatticeComplex f0(grid), f1(grid), f2(grid); - iQ2 = iQ * iQ; - iQ3 = iQ * iQ2; + iQ2 = iQ * iQ; + iQ3 = iQ * iQ2; - set_uw_complex(u, w, iQ2, iQ3); - set_fj_complex(f0, f1, f2, u, w); + set_uw(u, w, iQ2, iQ3); + set_fj(f0, f1, f2, u, w); - std::cout << "f0 " << f0 << std::endl; - std::cout << "f1 " << f1 << std::endl; - std::cout << "f2 " << f2 << std::endl; - std::cout << "iQ " << iQ << std::endl; - std::cout << "iQ2 " << iQ2 << std::endl; - - e_iQ = f0*unity + timesMinusI(f1) * iQ - f2 * iQ2; + e_iQ = f0*unity + timesMinusI(f1) * iQ - f2 * iQ2; - }; + }; - void set_uw(LatticeReal& u, LatticeReal& w, - GaugeLinkField& iQ2, GaugeLinkField& iQ3) const{ - Real one_over_three = 1.0/3.0; - Real one_over_two = 1.0/2.0; + void set_uw(LatticeComplex& u, LatticeComplex& w, + GaugeLinkField& iQ2, GaugeLinkField& iQ3) const{ + Complex one_over_three = 1.0/3.0; + Complex one_over_two = 1.0/2.0; - GridBase *grid = u._grid; - LatticeReal c0(grid), c1(grid), tmp(grid), c0max(grid), theta(grid); - - // sign in c0 from the conventions on the Ta - // c0 = - toReal(imag(trace(iQ3))) * one_over_three; - c0 = - toReal(real(timesMinusI(trace(iQ3)))) * one_over_three; //slow and temporary, FIX the bug in imag - c1 = - toReal(real(trace(iQ2))) * one_over_two; - tmp = c1 * one_over_three; - c0max = 2.0 * pow(tmp, 1.5); - - theta = acos(c0/c0max); - u = sqrt(tmp) * cos( theta * one_over_three); - w = sqrt(c1) * sin( theta * one_over_three); - - } - - void set_uw_complex(LatticeComplex& u, LatticeComplex& w, - GaugeLinkField& iQ2, GaugeLinkField& iQ3) const{ - Complex one_over_three = 1.0/3.0; - Complex one_over_two = 1.0/2.0; - - GridBase *grid = u._grid; - LatticeComplex c0(grid), c1(grid), tmp(grid), c0max(grid), theta(grid); + GridBase *grid = u._grid; + LatticeComplex c0(grid), c1(grid), tmp(grid), c0max(grid), theta(grid); // sign in c0 from the conventions on the Ta c0 = - real(timesMinusI(trace(iQ3))) * one_over_three; //temporary hack c1 = - real(trace(iQ2)) * one_over_two; //Cayley Hamilton checks to machine precision, tested - - std::cout << "c0 " << c0 << std::endl; - std::cout << "c1 " << c1 << std::endl; - tmp = c1 * one_over_three; c0max = 2.0 * pow(tmp, 1.5); - std::cout << "c0max " << c0max << std::endl; - LatticeComplex tempratio = c0/c0max; - std::cout << "ratio c0/c0max " << tempratio << std::endl; - theta = acos(c0/c0max); // divide by three here, now leave as it is - std::cout << "theta " << theta << std::endl; - - u = sqrt(tmp) * cos( theta * one_over_three); - w = sqrt(c1) * sin( theta * one_over_three); - - std::cout << "u " << u << std::endl; - std::cout << "w " << w << std::endl; - + theta = acos(c0/c0max)*one_over_three; // divide by three here, now leave as it is + u = sqrt(tmp) * cos( theta ); + w = sqrt(c1) * sin( theta ); } - void set_fj(LatticeComplex& f0, LatticeComplex& f1, LatticeComplex& f2, - const LatticeReal& u, const LatticeReal& w) const{ - - GridBase *grid = u._grid; - LatticeReal xi0(grid), u2(grid), w2(grid), cosw(grid), tmp(grid); - LatticeComplex fden(grid); - LatticeComplex h0(grid), h1(grid), h2(grid); - LatticeComplex e2iu(grid), emiu(grid), ixi0(grid), qt(grid); - - xi0 = func_xi0(w); - u2 = u * u; - w2 = w * w; - cosw = cos(w); - - ixi0 = timesI(toComplex(xi0)); - emiu = toComplex(cos(u)) - timesI(toComplex(sin(u))); - e2iu = toComplex(cos(2.0*u)) + timesI(toComplex(sin(2.0*u))); - - h0 = e2iu * toComplex(u2 - w2) + emiu *( toComplex(8.0*u2*cosw) + - toComplex(2.0*u*(3.0*u2 + w2))*ixi0); - - h1 = toComplex(2.0*u) * e2iu - emiu*( toComplex(2.0*u*cosw) - - toComplex(3.0*u2-w2)*ixi0); - - h2 = e2iu - emiu * (toComplex(cosw) + toComplex(3.0*u)*ixi0); - - tmp = 9.0*u2 - w2; - fden = toComplex(pow(tmp, -1.0)); - f0 = h0 * fden; - f1 = h1 * fden; - f2 = h2 * fden; - - - } - - void set_fj_complex(LatticeComplex& f0, LatticeComplex& f1, LatticeComplex& f2, const LatticeComplex& u, const LatticeComplex& w) const{ GridBase *grid = u._grid; @@ -212,47 +125,35 @@ LatticeComplex unity(grid); unity = 1.0; - xi0 = sin(w)/w;//func_xi0(w); - std::cout << "xi0 " << xi0 << std::endl; + xi0 = func_xi0(w); u2 = u * u; - std::cout << "u2 " << u2 << std::endl; w2 = w * w; - std::cout << "w2 " << w2 << std::endl; cosw = cos(w); - std::cout << "cosw " << cosw << std::endl; ixi0 = timesI(xi0); emiu = cos(u) - timesI(sin(u)); e2iu = cos(2.0*u) + timesI(sin(2.0*u)); - std::cout << "emiu " << emiu << std::endl; - std::cout << "e2iu " << e2iu << std::endl; h0 = e2iu * (u2 - w2) + emiu * ( (8.0*u2*cosw) + (2.0*u*(3.0*u2 + w2)*ixi0)); h1 = e2iu * (2.0 * u) - emiu * ( (2.0*u*cosw) - (3.0*u2-w2)*ixi0); h2 = e2iu - emiu * ( cosw + (3.0*u)*ixi0); - std::cout << "h0 " << h0 << std::endl; - std::cout << "h1 " << h1 << std::endl; - std::cout << "h2 " << h2 << std::endl; - fden = unity/(9.0*u2 - w2);// reals - std::cout << "fden " << fden << std::endl; f0 = h0 * fden; f1 = h1 * fden; f2 = h2 * fden; - } - LatticeReal func_xi0(const LatticeReal& w) const{ + LatticeComplex func_xi0(const LatticeComplex& w) const{ // Define a function to do the check //if( w < 1e-4 ) std::cout << GridLogWarning<< "[Smear_stout] w too small: "<< w <<"\n"; return sin(w)/w; } - LatticeReal func_xi1(const LatticeReal& w) const{ + LatticeComplex func_xi1(const LatticeComplex& w) const{ // Define a function to do the check //if( w < 1e-4 ) std::cout << GridLogWarning << "[Smear_stout] w too small: "<< w <<"\n"; return cos(w)/(w*w) - sin(w)/(w*w*w);