From 515ff6bf628529303ff3ae3fad2e91d9bbb4f56c Mon Sep 17 00:00:00 2001 From: Chulwoo Jung Date: Thu, 9 Nov 2023 21:42:46 -0500 Subject: [PATCH] Added Laplacian metric, Gauge OpenBC --- Grid/algorithms/LinearOperator.h | 47 ++ Grid/algorithms/approx/Forecast.h | 12 +- Grid/qcd/action/ActionCore.h | 1 + Grid/qcd/action/ActionParams.h | 13 + Grid/qcd/action/gauge/WilsonGaugeAction.h | 54 +- .../pseudofermion/ExactOneFlavourRatio.h | 9 +- Grid/qcd/hmc/GenericHMCrunner.h | 17 +- Grid/qcd/hmc/HMC.h | 2 + Grid/qcd/hmc/integrators/Integrator.h | 263 ++++++-- .../hmc/integrators/Integrator_algorithm.h | 190 +++++- Grid/qcd/utils/CovariantLaplacian.h | 220 ++++++- Grid/qcd/utils/CovariantLaplacianRat.h | 352 +++++++++++ Grid/qcd/utils/Metric.h | 76 ++- HMC/Mobius2p1p1fEOFA_4Gev.cc | 572 ++++++++++++++++++ 14 files changed, 1740 insertions(+), 88 deletions(-) create mode 100644 Grid/qcd/utils/CovariantLaplacianRat.h create mode 100644 HMC/Mobius2p1p1fEOFA_4Gev.cc diff --git a/Grid/algorithms/LinearOperator.h b/Grid/algorithms/LinearOperator.h index 5096231d..f0e1212a 100644 --- a/Grid/algorithms/LinearOperator.h +++ b/Grid/algorithms/LinearOperator.h @@ -460,6 +460,53 @@ class NonHermitianSchurDiagTwoOperator : public NonHermitianSchurOperatorBase +class QuadLinearOperator : public LinearOperatorBase { + Matrix &_Mat; +public: + RealD a0,a1,a2; + QuadLinearOperator(Matrix &Mat): _Mat(Mat),a0(0.),a1(0.),a2(1.) {}; + QuadLinearOperator(Matrix &Mat, RealD _a0,RealD _a1,RealD _a2): _Mat(Mat),a0(_a0),a1(_a1),a2(_a2) {}; + // Support for coarsening to a multigrid + void OpDiag (const Field &in, Field &out) { + assert(0); + _Mat.Mdiag(in,out); + } + void OpDir (const Field &in, Field &out,int dir,int disp) { + assert(0); + _Mat.Mdir(in,out,dir,disp); + } + void OpDirAll (const Field &in, std::vector &out){ + assert(0); + _Mat.MdirAll(in,out); + } + void HermOp (const Field &in, Field &out){ +// _Mat.M(in,out); + Field tmp1(in.Grid()); +// Linop.HermOpAndNorm(psi, mmp, d, b); + _Mat.M(in,tmp1); + _Mat.M(tmp1,out); + out *= a2; + axpy(out, a1, tmp1, out); + axpy(out, a0, in, out); +// d=real(innerProduct(psi,mmp)); +// b=norm2(mmp); + } + void AdjOp (const Field &in, Field &out){ + assert(0); + _Mat.M(in,out); + } + void HermOpAndNorm(const Field &in, Field &out,RealD &n1,RealD &n2){ + HermOp(in,out); + ComplexD dot= innerProduct(in,out); n1=real(dot); + n2=norm2(out); + } + void Op(const Field &in, Field &out){ + assert(0); + _Mat.M(in,out); + } +}; + /////////////////////////////////////////////////////////////////////////////////////////////////// // Left handed Moo^-1 ; (Moo - Moe Mee^-1 Meo) psi = eta --> ( 1 - Moo^-1 Moe Mee^-1 Meo ) psi = Moo^-1 eta // Right handed Moo^-1 ; (Moo - Moe Mee^-1 Meo) Moo^-1 Moo psi = eta --> ( 1 - Moe Mee^-1 Meo Moo^-1) phi=eta ; psi = Moo^-1 phi diff --git a/Grid/algorithms/approx/Forecast.h b/Grid/algorithms/approx/Forecast.h index 67596272..f19e0842 100644 --- a/Grid/algorithms/approx/Forecast.h +++ b/Grid/algorithms/approx/Forecast.h @@ -36,11 +36,12 @@ NAMESPACE_BEGIN(Grid); // Abstract base class. // Takes a matrix (Mat), a source (phi), and a vector of Fields (chi) // and returns a forecasted solution to the system D*psi = phi (psi). -template +// Changing to operator +template class Forecast { public: - virtual Field operator()(Matrix &Mat, const Field& phi, const std::vector& chi) = 0; + virtual Field operator()(LinearOperatorBase &Mat, const Field& phi, const std::vector& chi) = 0; }; // Implementation of Brower et al.'s chronological inverter (arXiv:hep-lat/9509012), @@ -54,13 +55,13 @@ public: Field operator()(Matrix &Mat, const Field& phi, const std::vector& prev_solns) { int degree = prev_solns.size(); + std::cout << GridLogMessage << "ChronoForecast: degree= " << degree << std::endl; Field chi(phi); // forecasted solution // Trivial cases if(degree == 0){ chi = Zero(); return chi; } else if(degree == 1){ return prev_solns[0]; } - // RealD dot; ComplexD xp; Field r(phi); // residual Field Mv(phi); @@ -83,8 +84,9 @@ public: // Perform sparse matrix multiplication and construct rhs for(int i=0; i NAMESPACE_CHECK(Metric); #include +#include NAMESPACE_CHECK(CovariantLaplacian); diff --git a/Grid/qcd/action/ActionParams.h b/Grid/qcd/action/ActionParams.h index 122dfb9c..a51c0dd3 100644 --- a/Grid/qcd/action/ActionParams.h +++ b/Grid/qcd/action/ActionParams.h @@ -65,6 +65,19 @@ struct WilsonImplParams { } }; +struct GaugeImplParams { +// bool overlapCommsCompute; +// AcceleratorVector twist_n_2pi_L; + AcceleratorVector boundary_phases; + GaugeImplParams() { + boundary_phases.resize(Nd, 1.0); +// twist_n_2pi_L.resize(Nd, 0.0); + }; + GaugeImplParams(const AcceleratorVector phi) : boundary_phases(phi) { +// twist_n_2pi_L.resize(Nd, 0.0); + } +}; + struct StaggeredImplParams { Coordinate dirichlet; // Blocksize of dirichlet BCs int partialDirichlet; diff --git a/Grid/qcd/action/gauge/WilsonGaugeAction.h b/Grid/qcd/action/gauge/WilsonGaugeAction.h index f535b54f..0156811d 100644 --- a/Grid/qcd/action/gauge/WilsonGaugeAction.h +++ b/Grid/qcd/action/gauge/WilsonGaugeAction.h @@ -42,9 +42,13 @@ template class WilsonGaugeAction : public Action { public: INHERIT_GIMPL_TYPES(Gimpl); + typedef GaugeImplParams ImplParams; + ImplParams Params; /////////////////////////// constructors - explicit WilsonGaugeAction(RealD beta_):beta(beta_){}; + explicit WilsonGaugeAction(RealD beta_, + const ImplParams &p = ImplParams() + ):beta(beta_),Params(p){}; virtual std::string action_name() {return "WilsonGaugeAction";} @@ -56,14 +60,53 @@ public: virtual void refresh(const GaugeField &U, GridSerialRNG &sRNG, GridParallelRNG &pRNG){}; // noop as no pseudoferms +// Umu<->U maximally confusing + virtual void boundary(const GaugeField &Umu, GaugeField &Ub){ + typedef typename Simd::scalar_type scalar_type; + assert(Params.boundary_phases.size() == Nd); + GridBase *GaugeGrid=Umu.Grid(); + GaugeLinkField U(GaugeGrid); + GaugeLinkField tmp(GaugeGrid); + + Lattice > coor(GaugeGrid); + for (int mu = 0; mu < Nd; mu++) { + ////////// boundary phase ///////////// + auto pha = Params.boundary_phases[mu]; + scalar_type phase( real(pha),imag(pha) ); + std::cout<< GridLogMessage << "[WilsonGaugeAction] boundary "<GlobalDimensions()[mu]; + int Lmu = L - 1; + + LatticeCoordinate(coor, mu); + + U = PeekIndex(Umu, mu); + tmp = where(coor == Lmu, phase * U, U); + PokeIndex(Ub, tmp, mu); +// PokeIndex(Ub, U, mu); +// PokeIndex(Umu, tmp, mu); + + } + }; + virtual RealD S(const GaugeField &U) { - RealD plaq = WilsonLoops::avgPlaquette(U); - RealD vol = U.Grid()->gSites(); + GaugeField Ub(U.Grid()); + this->boundary(U,Ub); + static RealD lastG=0.; + RealD plaq = WilsonLoops::avgPlaquette(Ub); + RealD vol = Ub.Grid()->gSites(); RealD action = beta * (1.0 - plaq) * (Nd * (Nd - 1.0)) * vol * 0.5; + std::cout << GridLogMessage << "[WilsonGaugeAction] dH: " << action-lastG << std::endl; + RealD plaq_o = WilsonLoops::avgPlaquette(U); + RealD action_o = beta * (1.0 - plaq_o) * (Nd * (Nd - 1.0)) * vol * 0.5; + std::cout << GridLogMessage << "[WilsonGaugeAction] U: " << action_o <<" Ub: "<< action << std::endl; + lastG=action; return action; }; virtual void deriv(const GaugeField &U, GaugeField &dSdU) { + GaugeField Ub(U.Grid()); + this->boundary(U,Ub); // not optimal implementation FIXME // extend Ta to include Lorentz indexes @@ -73,10 +116,9 @@ public: GaugeLinkField dSdU_mu(U.Grid()); for (int mu = 0; mu < Nd; mu++) { - Umu = PeekIndex(U, mu); - + Umu = PeekIndex(Ub, mu); // Staple in direction mu - WilsonLoops::Staple(dSdU_mu, U, mu); + WilsonLoops::Staple(dSdU_mu, Ub, mu); dSdU_mu = Ta(Umu * dSdU_mu) * factor; PokeIndex(dSdU, dSdU_mu, mu); diff --git a/Grid/qcd/action/pseudofermion/ExactOneFlavourRatio.h b/Grid/qcd/action/pseudofermion/ExactOneFlavourRatio.h index 9d4df1d3..86609563 100644 --- a/Grid/qcd/action/pseudofermion/ExactOneFlavourRatio.h +++ b/Grid/qcd/action/pseudofermion/ExactOneFlavourRatio.h @@ -178,7 +178,10 @@ NAMESPACE_BEGIN(Grid); // Use chronological inverter to forecast solutions across poles std::vector prev_solns; if(use_heatbath_forecasting){ prev_solns.reserve(param.degree); } - ChronoForecast, FermionField> Forecast; + MdagMLinearOperator ,FermionField> MdagML(Lop); + MdagMLinearOperator ,FermionField> MdagMR(Rop); +// ChronoForecast, FermionField> Forecast; + ChronoForecast, FermionField> , FermionField> Forecast; // \Phi = ( \alpha_{0} + \sum_{k=1}^{N_{p}} \alpha_{l} * \gamma_{l} ) * \eta RealD N(PowerNegHalf.norm); @@ -198,7 +201,7 @@ NAMESPACE_BEGIN(Grid); heatbathRefreshShiftCoefficients(0, -gamma_l); if(use_heatbath_forecasting){ // Forecast CG guess using solutions from previous poles Lop.Mdag(CG_src, Forecast_src); - CG_soln = Forecast(Lop, Forecast_src, prev_solns); + CG_soln = Forecast(MdagML, Forecast_src, prev_solns); SolverHBL(Lop, CG_src, CG_soln); prev_solns.push_back(CG_soln); } else { @@ -225,7 +228,7 @@ NAMESPACE_BEGIN(Grid); heatbathRefreshShiftCoefficients(1, -gamma_l*PowerNegHalf.poles[k]); if(use_heatbath_forecasting){ Rop.Mdag(CG_src, Forecast_src); - CG_soln = Forecast(Rop, Forecast_src, prev_solns); + CG_soln = Forecast(MdagMR, Forecast_src, prev_solns); SolverHBR(Rop, CG_src, CG_soln); prev_solns.push_back(CG_soln); } else { diff --git a/Grid/qcd/hmc/GenericHMCrunner.h b/Grid/qcd/hmc/GenericHMCrunner.h index 1429d848..4ff92b7e 100644 --- a/Grid/qcd/hmc/GenericHMCrunner.h +++ b/Grid/qcd/hmc/GenericHMCrunner.h @@ -121,12 +121,19 @@ public: template void Run(SmearingPolicy &S) { - Runner(S); + TrivialMetric Mtr; + Runner(S,Mtr); + } + + template + void Run(SmearingPolicy &S, Metric &Mtr) { + Runner(S,Mtr); } void Run(){ NoSmearing S; - Runner(S); + TrivialMetric Mtr; + Runner(S,Mtr); } //Use the checkpointer to initialize the RNGs and the gauge field, writing the resulting gauge field into U. @@ -176,15 +183,15 @@ public: ////////////////////////////////////////////////////////////////// private: - template - void Runner(SmearingPolicy &Smearing) { + template + void Runner(SmearingPolicy &Smearing, Metric &Mtr) { auto UGrid = Resources.GetCartesian(); Field U(UGrid); initializeGaugeFieldAndRNGs(U); typedef IntegratorType TheIntegrator; - TheIntegrator MDynamics(UGrid, Parameters.MD, TheAction, Smearing); + TheIntegrator MDynamics(UGrid, Parameters.MD, TheAction, Smearing,Mtr); // Sets the momentum filter MDynamics.setMomentumFilter(*(Resources.GetMomentumFilter())); diff --git a/Grid/qcd/hmc/HMC.h b/Grid/qcd/hmc/HMC.h index c56ae6ad..f91f03e3 100644 --- a/Grid/qcd/hmc/HMC.h +++ b/Grid/qcd/hmc/HMC.h @@ -55,6 +55,8 @@ struct HMCparameters: Serializable { Integer, NoMetropolisUntil, bool, PerformRandomShift, /* @brief Randomly shift the gauge configuration at the start of a trajectory */ std::string, StartingType, + Integer, SW, + RealD, Kappa, IntegratorParameters, MD) HMCparameters() { diff --git a/Grid/qcd/hmc/integrators/Integrator.h b/Grid/qcd/hmc/integrators/Integrator.h index 4dd5a634..1673905d 100644 --- a/Grid/qcd/hmc/integrators/Integrator.h +++ b/Grid/qcd/hmc/integrators/Integrator.h @@ -9,6 +9,7 @@ Copyright (C) 2015 Author: Azusa Yamaguchi Author: Peter Boyle Author: Guido Cossu +Author: Chulwoo Jung 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 @@ -41,10 +42,19 @@ public: GRID_SERIALIZABLE_CLASS_MEMBERS(IntegratorParameters, std::string, name, // name of the integrator unsigned int, MDsteps, // number of outer steps + RealD, RMHMCTol, + RealD, RMHMCCGTol, + RealD, lambda0, + RealD, lambda1, + RealD, lambda2, RealD, trajL) // trajectory length IntegratorParameters(int MDsteps_ = 10, RealD trajL_ = 1.0) : MDsteps(MDsteps_), + lambda0(0.1931833275037836), + lambda1(0.1931833275037836), + lambda2(0.1931833275037836), + RMHMCTol(1e-8),RMHMCCGTol(1e-8), trajL(trajL_) {}; template ::value, int >::type = 0 > @@ -75,7 +85,8 @@ public: double t_U; // Track time passing on each level and for U and for P std::vector t_P; - MomentaField P; +// MomentaField P; + GeneralisedMomenta P; SmearingPolicy& Smearer; RepresentationPolicy Representations; IntegratorParameters Params; @@ -96,7 +107,16 @@ public: void update_P(Field& U, int level, double ep) { t_P[level] += ep; - update_P(P, U, level, ep); + update_P(P.Mom, U, level, ep); + + std::cout << GridLogIntegrator << "[" << level << "] P " << " dt " << ep << " : t_P " << t_P[level] << std::endl; + } + + void update_P2(Field& U, int level, double ep) + { + t_P[level] += ep; + update_P2(P.Mom, U, level, ep); + std::cout << GridLogIntegrator << "[" << level << "] P " << " dt " << ep << " : t_P " << t_P[level] << std::endl; } @@ -119,62 +139,167 @@ public: } } update_P_hireps{}; - void update_P(MomentaField& Mom, Field& U, int level, double ep) { // input U actually not used in the fundamental case // Fundamental updates, include smearing for (int a = 0; a < as[level].actions.size(); ++a) { - double start_full = usecond(); Field force(U.Grid()); conformable(U.Grid(), Mom.Grid()); + Field& Us = Smearer.get_U(as[level].actions.at(a)->is_smeared); double start_force = usecond(); + as[level].actions.at(a)->deriv(Us, force); // deriv should NOT include Ta - as[level].actions.at(a)->deriv_timer_start(); - as[level].actions.at(a)->deriv(Smearer, force); // deriv should NOT include Ta - as[level].actions.at(a)->deriv_timer_stop(); - - auto name = as[level].actions.at(a)->action_name(); - + std::cout << GridLogIntegrator << "Smearing (on/off): " << as[level].actions.at(a)->is_smeared << std::endl; + if (as[level].actions.at(a)->is_smeared) Smearer.smeared_force(force); force = FieldImplementation::projectForce(force); // Ta for gauge fields double end_force = usecond(); - - MomFilter->applyFilter(force); - - std::cout << GridLogIntegrator << " update_P : Level [" << level <<"]["<gSites()); //average per-site norm. nb. norm2(latt) = \sum_x norm2(latt[x]) - Real impulse_abs = force_abs * ep * HMC_MOMENTUM_DENOMINATOR; - - Real force_max = std::sqrt(maxLocalNorm2(force)); - Real impulse_max = force_max * ep * HMC_MOMENTUM_DENOMINATOR; - - as[level].actions.at(a)->deriv_log(force_abs,force_max,impulse_abs,impulse_max); - - std::cout << GridLogIntegrator<< "["<gSites()); + std::cout << GridLogIntegrator << "["<is_smeared); + double start_force = usecond(); + as[level].actions.at(a)->deriv(Us, force); // deriv should NOT include Ta + + std::cout << GridLogIntegrator << "Smearing (on/off): " << as[level].actions.at(a)->is_smeared << std::endl; + if (as[level].actions.at(a)->is_smeared) Smearer.smeared_force(force); + force = FieldImplementation::projectForce(force); // Ta for gauge fields + double end_force = usecond(); + Real force_abs = std::sqrt(norm2(force)/U.Grid()->gSites()); + std::cout << GridLogIntegrator << "["<is_smeared); + as[level].actions.at(a)->deriv(Us, force); // deriv should NOT include Ta + + std::cout << GridLogIntegrator << "Smearing (on/off): " << as[level].actions.at(a)->is_smeared << std::endl; + if (as[level].actions.at(a)->is_smeared) Smearer.smeared_force(force); + force = FieldImplementation::projectForce(force); // Ta for gauge fields + Real force_abs = std::sqrt(norm2(force) / U.Grid()->gSites()); + std::cout << GridLogIntegrator << "|Force| site average: " << force_abs + << std::endl; + Msum += force; + } + + MomentaField NewMom = P.Mom; + MomentaField OldMom = P.Mom; + double threshold = Params.RMHMCTol; + P.M.ImportGauge(U); + MomentaField MomDer(P.Mom.Grid()); + MomentaField MomDer1(P.Mom.Grid()); + MomentaField AuxDer(P.Mom.Grid()); + MomDer1 = Zero(); + MomentaField diff(P.Mom.Grid()); + double factor = 2.0; + if (intermediate){ + P.DerivativeU(P.Mom, MomDer1); + factor = 1.0; + } +// std::cout << GridLogIntegrator << "MomDer1 implicit_update_P: " << std::sqrt(norm2(MomDer1)) << std::endl; + + // Auxiliary fields + P.update_auxiliary_momenta(ep*0.5 ); + P.AuxiliaryFieldsDerivative(AuxDer); + Msum += AuxDer; + + + // Here run recursively + int counter = 1; + RealD RelativeError; + do { + std::cout << GridLogIntegrator << "UpdateP implicit step "<< counter << std::endl; + + // Compute the derivative of the kinetic term + // with respect to the gauge field + P.DerivativeU(NewMom, MomDer); + Real force_abs = std::sqrt(norm2(MomDer) / U.Grid()->gSites()); + std::cout << GridLogIntegrator << "|Force| laplacian site average: " << force_abs + << std::endl; + + NewMom = P.Mom - ep* 0.5 * HMC_MOMENTUM_DENOMINATOR * (2.0*Msum + factor*MomDer + MomDer1);// simplify + diff = NewMom - OldMom; + counter++; + RelativeError = std::sqrt(norm2(diff))/std::sqrt(norm2(NewMom)); + std::cout << GridLogIntegrator << "UpdateP RelativeError: " << RelativeError << std::endl; + OldMom = NewMom; + } while (RelativeError > threshold); + + P.Mom = NewMom; + std::cout << GridLogIntegrator << "NewMom implicit_update_P: " << std::sqrt(norm2(NewMom)) << std::endl; + + // update the auxiliary fields momenta + P.update_auxiliary_momenta(ep*0.5 ); } void update_U(Field& U, double ep) { - update_U(P, U, ep); + update_U(P.Mom, U, ep); t_U += ep; int fl = levels - 1; @@ -183,12 +308,8 @@ public: void update_U(MomentaField& Mom, Field& U, double ep) { - MomentaField MomFiltered(Mom.Grid()); - MomFiltered = Mom; - MomFilter->applyFilter(MomFiltered); - // exponential of Mom*U in the gauge fields case - FieldImplementation::update_field(MomFiltered, U, ep); + FieldImplementation::update_field(Mom, U, ep); // Update the smeared fields, can be implemented as observer Smearer.set_Field(U); @@ -197,15 +318,70 @@ public: Representations.update(U); // void functions if fundamental representation } + void implicit_update_U(Field&U, double ep, double ep1 ){ + double ep2=ep-ep1; + t_U += ep; + int fl = levels - 1; + std::cout << GridLogIntegrator << " " << "[" << fl << "] U " << " dt " << ep << " : t_U " << t_U << std::endl; + std::cout << GridLogIntegrator << "U before implicit_update_U: " << std::sqrt(norm2(U)) << std::endl; + + MomentaField Mom1(P.Mom.Grid()); + MomentaField Mom2(P.Mom.Grid()); + RealD RelativeError; + Field diff(U.Grid()); + Real threshold = Params.RMHMCTol; + int counter = 1; + int MaxCounter = 100; + + Field OldU = U; + Field NewU = U; + + P.M.ImportGauge(U); + P.DerivativeP(Mom1); // first term in the derivative + std::cout << GridLogIntegrator << "implicit_update_U: Mom1: " << std::sqrt(norm2(Mom1)) << std::endl; + + P.update_auxiliary_fields(ep1); + + + MomentaField sum=Mom1; + do { + std::cout << GridLogIntegrator << "UpdateU implicit step "<< counter << std::endl; + + P.DerivativeP(Mom2); // second term in the derivative, on the updated U + std::cout << GridLogIntegrator << "implicit_update_U: Mom1: " << std::sqrt(norm2(Mom1)) << std::endl; + sum = (Mom1*ep1 + Mom2*ep2); + + for (int mu = 0; mu < Nd; mu++) { + auto Umu = PeekIndex(U, mu); + auto Pmu = PeekIndex(sum, mu); + Umu = expMat(Pmu, 1, 12) * Umu; + PokeIndex(NewU, ProjectOnGroup(Umu), mu); + } + + diff = NewU - OldU; + RelativeError = std::sqrt(norm2(diff))/std::sqrt(norm2(NewU)); + std::cout << GridLogIntegrator << "UpdateU RelativeError: " << RelativeError << std::endl; + + P.M.ImportGauge(NewU); + OldU = NewU; // some redundancy to be eliminated + counter++; + } while (RelativeError > threshold && counter < MaxCounter); + + U = NewU; + std::cout << GridLogIntegrator << "NewU implicit_update_U: " << std::sqrt(norm2(U)) << std::endl; + P.update_auxiliary_fields(ep2); + } + + virtual void step(Field& U, int level, int first, int last) = 0; public: Integrator(GridBase* grid, IntegratorParameters Par, ActionSet& Aset, - SmearingPolicy& Sm) + SmearingPolicy& Sm, Metric& M) : Params(Par), as(Aset), - P(grid), + P(grid, M), levels(Aset.size()), Smearer(Sm), Representations(grid) @@ -324,7 +500,8 @@ public: void reverse_momenta() { - P *= -1.0; + P.Mom *= -1.0; + P.AuxMom *= -1.0; } // to be used by the actionlevel class to iterate @@ -343,11 +520,11 @@ public: // Initialization of momenta and actions void refresh(Field& U, GridSerialRNG & sRNG, GridParallelRNG& pRNG) { - assert(P.Grid() == U.Grid()); + assert(P.Mom.Grid() == U.Grid()); std::cout << GridLogIntegrator << "Integrator refresh" << std::endl; std::cout << GridLogIntegrator << "Generating momentum" << std::endl; - FieldImplementation::generate_momenta(P, sRNG, pRNG); + FieldImplementation::generate_momenta(P.Mom, sRNG, pRNG); // Update the smeared fields, can be implemented as observer // necessary to keep the fields updated even after a reject @@ -402,7 +579,7 @@ public: std::cout << GridLogIntegrator << "Integrator action\n"; - RealD H = - FieldImplementation::FieldSquareNorm(P)/HMC_MOMENTUM_DENOMINATOR; // - trace (P*P)/denom + RealD H = - FieldImplementation::FieldSquareNorm(P.Mom)/HMC_MOMENTUM_DENOMINATOR; // - trace (P*P)/denom RealD Hterm; @@ -446,7 +623,7 @@ public: std::cout << GridLogIntegrator << "Integrator initial action\n"; - RealD H = - FieldImplementation::FieldSquareNorm(P)/HMC_MOMENTUM_DENOMINATOR; // - trace (P*P)/denom + RealD H = - FieldImplementation::FieldSquareNorm(P.Mom)/HMC_MOMENTUM_DENOMINATOR; // - trace (P*P)/denom RealD Hterm; diff --git a/Grid/qcd/hmc/integrators/Integrator_algorithm.h b/Grid/qcd/hmc/integrators/Integrator_algorithm.h index 9c70fd1f..c74c02d6 100644 --- a/Grid/qcd/hmc/integrators/Integrator_algorithm.h +++ b/Grid/qcd/hmc/integrators/Integrator_algorithm.h @@ -102,8 +102,8 @@ public: std::string integrator_name(){return "LeapFrog";} - LeapFrog(GridBase* grid, IntegratorParameters Par, ActionSet& Aset, SmearingPolicy& Sm) - : Integrator(grid, Par, Aset, Sm){}; + LeapFrog(GridBase* grid, IntegratorParameters Par, ActionSet& Aset, SmearingPolicy& Sm, Metric& M) + : Integrator(grid, Par, Aset, Sm,M){}; void step(Field& U, int level, int _first, int _last) { int fl = this->as.size() - 1; @@ -146,8 +146,8 @@ public: typedef FieldImplementation_ FieldImplementation; INHERIT_FIELD_TYPES(FieldImplementation); - MinimumNorm2(GridBase* grid, IntegratorParameters Par, ActionSet& Aset, SmearingPolicy& Sm) - : Integrator(grid, Par, Aset, Sm){}; + MinimumNorm2(GridBase* grid, IntegratorParameters Par, ActionSet& Aset, SmearingPolicy& Sm, Metric& M) + : Integrator(grid, Par, Aset, Sm,M){}; std::string integrator_name(){return "MininumNorm2";} @@ -210,9 +210,9 @@ public: // Looks like dH scales as dt^4. tested wilson/wilson 2 level. ForceGradient(GridBase* grid, IntegratorParameters Par, ActionSet& Aset, - SmearingPolicy& Sm) + SmearingPolicy& Sm, Metric& M) : Integrator( - grid, Par, Aset, Sm){}; + grid, Par, Aset, Sm,M){}; std::string integrator_name(){return "ForceGradient";} @@ -275,6 +275,184 @@ public: } }; +//////////////////////////////// +// Riemannian Manifold HMC +// Girolami et al +//////////////////////////////// + + + +// correct +template > +class ImplicitLeapFrog : public Integrator { + public: + typedef ImplicitLeapFrog + Algorithm; + INHERIT_FIELD_TYPES(FieldImplementation); + + // Riemannian manifold metric operator + // Hermitian operator Fisher + + std::string integrator_name(){return "ImplicitLeapFrog";} + + ImplicitLeapFrog(GridBase* grid, IntegratorParameters Par, + ActionSet& Aset, SmearingPolicy& Sm, Metric& M) + : Integrator( + grid, Par, Aset, Sm, M){}; + + void step(Field& U, int level, int _first, int _last) { + int fl = this->as.size() - 1; + // level : current level + // fl : final level + // eps : current step size + + // Get current level step size + RealD eps = this->Params.trajL/this->Params.MDsteps; + for (int l = 0; l <= level; ++l) eps /= this->as[l].multiplier; + + int multiplier = this->as[level].multiplier; + for (int e = 0; e < multiplier; ++e) { + int first_step = _first && (e == 0); + int last_step = _last && (e == multiplier - 1); + + if (first_step) { // initial half step + this->implicit_update_P(U, level, eps / 2.0); + } + + if (level == fl) { // lowest level + this->implicit_update_U(U, eps,eps/2.); + } else { // recursive function call + this->step(U, level + 1, first_step, last_step); + } + + //int mm = last_step ? 1 : 2; + if (last_step){ + this->update_P2(U, level, eps / 2.0); + } else { + this->implicit_update_P(U, level, eps, true);// works intermediate step + } + } + } +}; + + +template > +class ImplicitMinimumNorm2 : public Integrator { + private: +// const RealD lambda = 0.1931833275037836; + + public: + INHERIT_FIELD_TYPES(FieldImplementation); + + ImplicitMinimumNorm2(GridBase* grid, IntegratorParameters Par, + ActionSet& Aset, SmearingPolicy& Sm, Metric& M) + : Integrator( + grid, Par, Aset, Sm, M){}; + + std::string integrator_name(){return "ImplicitMininumNorm2";} + + void step(Field& U, int level, int _first, int _last) { + // level : current level + // fl : final level + // eps : current step size + + int fl = this->as.size() - 1; +// assert(Params.lambda.size()>level); +// RealD lambda= Params.lambda[level]; + assert(level<3); + RealD lambda= this->Params.lambda0; + if (level>0) lambda= this->Params.lambda1; + if (level>1) lambda= this->Params.lambda2; + std::cout << GridLogMessage << "level: "<Params.trajL/this->Params.MDsteps * 2.0; + for (int l = 0; l <= level; ++l) eps /= 2.0 * this->as[l].multiplier; + + // Nesting: 2xupdate_U of size eps/2 + // Next level is eps/2/multiplier + + int multiplier = this->as[level].multiplier; + for (int e = 0; e < multiplier; ++e) { // steps per step + + int first_step = _first && (e == 0); + int last_step = _last && (e == multiplier - 1); + + if (first_step) { // initial half step + this->update_P(U, level, lambda * eps); + } + + if (level == fl) { // lowest level + this->update_U(U, 0.5 * eps); + } else { // recursive function call + this->step(U, level + 1, first_step, 0); + } + + this->update_P(U, level, (1.0 - 2.0 * lambda) * eps); + + if (level == fl) { // lowest level + this->update_U(U, 0.5 * eps); + } else { // recursive function call + this->step(U, level + 1, 0, last_step); + } + + int mm = (last_step) ? 1 : 2; + this->update_P(U, level, lambda * eps * mm); + } + } + else + { // last level + RealD eps = this->Params.trajL/this->Params.MDsteps * 2.0; + for (int l = 0; l <= level; ++l) eps /= 2.0 * this->as[l].multiplier; + + // Nesting: 2xupdate_U of size eps/2 + // Next level is eps/2/multiplier + + int multiplier = this->as[level].multiplier; + for (int e = 0; e < multiplier; ++e) { // steps per step + + int first_step = _first && (e == 0); + int last_step = _last && (e == multiplier - 1); + + if (first_step) { // initial half step + this->implicit_update_P(U, level, lambda * eps); + } + + if (level == fl) { // lowest level + this->implicit_update_U(U, 0.5 * eps,lambda*eps); + } else { // recursive function call + this->step(U, level + 1, first_step, 0); + } + + this->implicit_update_P(U, level, (1.0 - 2.0 * lambda) * eps, true); + + if (level == fl) { // lowest level + this->implicit_update_U(U, 0.5 * eps, (0.5-lambda)*eps); + } else { // recursive function call + this->step(U, level + 1, 0, last_step); + } + + //int mm = (last_step) ? 1 : 2; + //this->update_P(U, level, lambda * eps * mm); + + if (last_step) { + this->update_P2(U, level, eps * lambda); + } else { + this->implicit_update_P(U, level, lambda * eps*2.0, true); + } + } + } + + } +}; + NAMESPACE_END(Grid); #endif // INTEGRATOR_INCLUDED diff --git a/Grid/qcd/utils/CovariantLaplacian.h b/Grid/qcd/utils/CovariantLaplacian.h index 94322507..d6323ed2 100644 --- a/Grid/qcd/utils/CovariantLaplacian.h +++ b/Grid/qcd/utils/CovariantLaplacian.h @@ -54,7 +54,133 @@ struct LaplacianParams : Serializable { precision(precision){}; }; +#define LEG_LOAD(Dir) \ + SE = st.GetEntry(ptype, Dir, ss); \ + if (SE->_is_local ) { \ + int perm= SE->_permute; \ + chi = coalescedReadPermute(in[SE->_offset],ptype,perm,lane); \ + } else { \ + chi = coalescedRead(buf[SE->_offset],lane); \ + } \ + acceleratorSynchronise(); +const std::vector directions4D ({Xdir,Ydir,Zdir,Tdir,Xdir,Ydir,Zdir,Tdir}); +const std::vector displacements4D({1,1,1,1,-1,-1,-1,-1}); + +template class CovariantAdjointLaplacianStencil : public SparseMatrixBase +{ +public: + INHERIT_GIMPL_TYPES(Gimpl); +// RealD kappa; + + typedef typename Field::vector_object siteObject; + + template using iImplDoubledGaugeField = iVector >, Nds>; + typedef iImplDoubledGaugeField SiteDoubledGaugeField; + typedef Lattice DoubledGaugeField; + typedef CartesianStencil StencilImpl; + + GridBase *grid; + StencilImpl Stencil; + SimpleCompressor Compressor; + DoubledGaugeField Uds; + + CovariantAdjointLaplacianStencil( GridBase *_grid) + : grid(_grid), + Stencil (grid,8,Even,directions4D,displacements4D), + Uds(grid){} + + CovariantAdjointLaplacianStencil(GaugeField &Umu) + : + grid(Umu.Grid()), + Stencil (grid,8,Even,directions4D,displacements4D), + Uds(grid) + { GaugeImport(Umu); } + + void GaugeImport (const GaugeField &Umu) + { + assert(grid == Umu.Grid()); + for (int mu = 0; mu < Nd; mu++) { + auto U = PeekIndex(Umu, mu); + PokeIndex(Uds, U, mu ); + U = adj(Cshift(U, mu, -1)); + PokeIndex(Uds, U, mu + 4); + } + }; + + virtual GridBase *Grid(void) { return grid; }; + + virtual void M (const Field &_in, Field &_out) + { + /////////////////////////////////////////////// + // Halo exchange for this geometry of stencil + /////////////////////////////////////////////// + Stencil.HaloExchange(_in, Compressor); + + /////////////////////////////////// + // Arithmetic expressions + /////////////////////////////////// + auto st = Stencil.View(AcceleratorRead); + auto buf = st.CommBuf(); + + autoView( in , _in , AcceleratorRead); + autoView( out , _out , AcceleratorWrite); + autoView( U , Uds , AcceleratorRead); + + typedef typename Field::vector_object vobj; + typedef decltype(coalescedRead(in[0])) calcObj; + typedef decltype(coalescedRead(U[0](0))) calcLink; + + const int Nsimd = vobj::Nsimd(); + const uint64_t NN = grid->oSites(); + + accelerator_for( ss, NN, Nsimd, { + + StencilEntry *SE; + + const int lane=acceleratorSIMTlane(Nsimd); + + calcObj chi; + calcObj res; + calcObj Uchi; + calcObj Utmp; + calcObj Utmp2; + calcLink UU; + calcLink Udag; + int ptype; + + res = coalescedRead(in[ss])*(-8.0); + +#define LEG_LOAD_MULT(leg,polarisation) \ + UU = coalescedRead(U[ss](polarisation)); \ + Udag = adj(UU); \ + LEG_LOAD(leg); \ + mult(&Utmp(), &UU, &chi()); \ + Utmp2 = adj(Utmp); \ + mult(&Utmp(), &UU, &Utmp2()); \ + Uchi = adj(Utmp); \ + res = res + Uchi; + + LEG_LOAD_MULT(0,Xp); + LEG_LOAD_MULT(1,Yp); + LEG_LOAD_MULT(2,Zp); + LEG_LOAD_MULT(3,Tp); + LEG_LOAD_MULT(4,Xm); + LEG_LOAD_MULT(5,Ym); + LEG_LOAD_MULT(6,Zm); + LEG_LOAD_MULT(7,Tm); + + coalescedWrite(out[ss], res,lane); + }); + }; + virtual void Mdag (const Field &in, Field &out) { M(in,out);}; // Laplacian is hermitian + virtual void Mdiag (const Field &in, Field &out) {assert(0);}; // Unimplemented need only for multigrid + virtual void Mdir (const Field &in, Field &out,int dir, int disp){assert(0);}; // Unimplemented need only for multigrid + virtual void MdirAll (const Field &in, std::vector &out) {assert(0);}; // Unimplemented need only for multigrid +}; + +#undef LEG_LOAD_MULT +#undef LEG_LOAD //////////////////////////////////////////////////////////// // Laplacian operator L on adjoint fields @@ -76,29 +202,40 @@ class LaplacianAdjointField: public Metric { LaplacianParams param; MultiShiftFunction PowerHalf; MultiShiftFunction PowerInvHalf; +//template class CovariantAdjointLaplacianStencil : public SparseMatrixBase + CovariantAdjointLaplacianStencil LapStencil; public: INHERIT_GIMPL_TYPES(Impl); - LaplacianAdjointField(GridBase* grid, OperatorFunction& S, LaplacianParams& p, const RealD k = 1.0) - : U(Nd, grid), Solver(S), param(p), kappa(k){ + LaplacianAdjointField(GridBase* grid, OperatorFunction& S, LaplacianParams& p, const RealD k = 1.0, bool if_remez=true) + : U(Nd, grid), Solver(S), param(p), kappa(k) + ,LapStencil(grid){ AlgRemez remez(param.lo,param.hi,param.precision); std::cout<triv=0; }; - + LaplacianAdjointField(){this->triv=0; printf("triv=%d\n",this->Trivial());} void Mdir(const GaugeField&, GaugeField&, int, int){ assert(0);} void MdirAll(const GaugeField&, std::vector &){ assert(0);} void Mdiag(const GaugeField&, GaugeField&){ assert(0);} void ImportGauge(const GaugeField& _U) { + RealD total=0.; for (int mu = 0; mu < Nd; mu++) { U[mu] = PeekIndex(_U, mu); + total += norm2(U[mu]); } + LapStencil.GaugeImport (_U); + + std::cout << GridLogDebug <<"ImportGauge:norm2(U _U) = "< + +NAMESPACE_BEGIN(Grid); + +struct LaplacianRatParams { + + RealD offset; + int order; + std::vector a0; + std::vector a1; + std::vector b0; + std::vector b1; + RealD b2; //for debugging + int MaxIter; + RealD tolerance; + int precision; + + // constructor + LaplacianRatParams(int ord = 1, + int maxit = 1000, + RealD tol = 1.0e-8, + int precision = 64) + : offset(1.), order(ord),b2(1.), + MaxIter(maxit), + tolerance(tol), + precision(precision){ + a0.resize(ord,0.); + a1.resize(ord,0.); + b0.resize(ord,0.); + b1.resize(ord,0.); + }; +}; + + + +//////////////////////////////////////////////////////////// +// Laplacian operator L on adjoint fields +// +// phi: adjoint field +// L: D_mu^dag D_mu +// +// L phi(x) = Sum_mu [ U_mu(x)phi(x+mu)U_mu(x)^dag + +// U_mu(x-mu)^dag phi(x-mu)U_mu(x-mu) +// -2phi(x)] +// +// Operator designed to be encapsulated by +// an HermitianLinearOperator<.. , ..> +//////////////////////////////////////////////////////////// + +template +class LaplacianAdjointRat: public Metric { + OperatorFunction &Solver; + LaplacianRatParams Gparam; + LaplacianRatParams Mparam; + GridBase *grid; + GridBase *grid_f; + CovariantAdjointLaplacianStencil LapStencil; +public: + INHERIT_GIMPL_TYPES(Impl); + typedef typename ImplF::Field GaugeFieldF; + GaugeField Usav; + GaugeFieldF UsavF; + std::vector< std::vector > prev_solnsM; + std::vector< std::vector > prev_solnsMinv; + std::vector< std::vector > prev_solnsMDeriv; + std::vector< std::vector > prev_solnsMinvDeriv; + + LaplacianAdjointRat(GridBase* _grid, GridBase* _grid_f, OperatorFunction& S, LaplacianRatParams& gpar, LaplacianRatParams& mpar) + : grid(_grid),grid_f(_grid_f), LapStencil(grid), U(Nd, _grid), Solver(S), Gparam(gpar), Mparam(mpar),Usav(_grid), UsavF(_grid_f), + prev_solnsM(4),prev_solnsMinv(4),prev_solnsMDeriv(4),prev_solnsMinvDeriv(4) { +// std::cout<triv=0; + + + }; + LaplacianAdjointRat(){this->triv=0; printf("triv=%d\n",this->Trivial());} + void Mdir(const GaugeField&, GaugeField&, int, int){ assert(0);} + void MdirAll(const GaugeField&, std::vector &){ assert(0);} + void Mdiag(const GaugeField&, GaugeField&){ assert(0);} + + void ImportGauge(const GaugeField& _U) { + RealD total=0.; + for (int mu = 0; mu < Nd; mu++) { + U[mu] = PeekIndex(_U, mu); + total += norm2(U[mu]); + } + Usav = _U; + precisionChange(UsavF,Usav); + std::cout <(left, nu); +// GaugeLinkField right_nu = PeekIndex(right, nu); + der_mu += U[mu] * Cshift(left, mu, 1) * adj(U[mu]) * right; + der_mu += U[mu] * Cshift(right, mu, 1) * adj(U[mu]) * left; +// } + PokeIndex(der, -factor * der_mu, mu); + } + std::cout << GridLogDebug <<"MDerivLink: norm2(der) = "< >& prev_solns ) { + +// get rid of this please + RealD fac = - 1. / (double(4 * Nd)) ; + RealD coef=0.5; + LapStencil.GaugeImport(Usav); + + +for (int nu=0;nu(right, nu); + GaugeLinkField left_nu = PeekIndex(left, nu); + GaugeLinkField LMinvMom(left.Grid()); + + GaugeLinkField GMom(left.Grid()); + GaugeLinkField LMinvGMom(left.Grid()); + + GaugeLinkField AGMom(left.Grid()); + GaugeLinkField MinvAGMom(left.Grid()); + GaugeLinkField LMinvAGMom(left.Grid()); + + GaugeLinkField AMinvMom(left.Grid()); + GaugeLinkField LMinvAMom(left.Grid()); + GaugeLinkField temp(left.Grid()); + GaugeLinkField temp2(left.Grid()); + + std::vector MinvMom(par.order,left.Grid()); + + GaugeLinkField MinvGMom(left.Grid()); + GaugeLinkField Gtemp(left.Grid()); + GaugeLinkField Gtemp2(left.Grid()); + + + ConjugateGradient CG(par.tolerance,10000,false); +// ConjugateGradient CG_f(par.tolerance,10000,false); + LaplacianParams LapPar(0.0001, 1.0, 10000, 1e-8, 12, 64); + + ChronoForecast< QuadLinearOperator,GaugeLinkField> , GaugeLinkField> Forecast; + + GMom = par.offset * right_nu; + + for(int i =0;i,GaugeLinkField> QuadOp(LapStencil,par.b0[i],fac*par.b1[i],fac*fac*par.b2); +#if USE_CHRONO + MinvMom[i] = Forecast(QuadOp, right_nu, prev_solns[nu]); +#endif +#ifndef MIXED_CG + CG(QuadOp,right_nu,MinvMom[i]); +#else + QuadLinearOperator,GaugeLinkFieldF> QuadOpF(LaplacianF,par.b0[i],par.b1[i],par.b2); + MixedPrecisionConjugateGradient MixedCG(par.tolerance,10000,10000,grid_f,QuadOpF,QuadOp); + MixedCG.InnerTolerance=par.tolerance; + MixedCG(right_nu,MinvMom[i]); +#endif +#if USE_CHRONO + prev_solns[nu].push_back(MinvMom[i]); +#endif + + GMom += par.a0[i]*MinvMom[i]; + LapStencil.M(MinvMom[i],Gtemp2); + GMom += par.a1[i]*fac*Gtemp2; + } + for(int i =0;i,GaugeLinkField> QuadOp(LapStencil,par.b0[i],fac*par.b1[i],fac*fac*par.b2); + + MinvGMom = Forecast(QuadOp, GMom, prev_solns[nu]); +#ifndef MIXED_CG + CG(QuadOp,GMom,MinvGMom); + LapStencil.M(MinvGMom, Gtemp2); LMinvGMom=fac*Gtemp2; + CG(QuadOp,right_nu,MinvMom[i]); +#else + QuadLinearOperator,GaugeLinkFieldF> QuadOpF(LaplacianF,par.b0[i],par.b1[i],par.b2); + MixedPrecisionConjugateGradient MixedCG(par.tolerance,10000,10000,grid_f,QuadOpF,QuadOp); + MixedCG.InnerTolerance=par.tolerance; + MixedCG(GMom,MinvGMom); + Laplacian.M(MinvGMom, LMinvGMom); + MixedCG(right_nu,MinvMom[i]); +#endif +#if USE_CHRONO + prev_solns[nu].push_back(MinvGMom); +#endif + + LapStencil.M(MinvMom[i], Gtemp2); LMinvMom=fac*Gtemp2; + AMinvMom = par.a1[i]*LMinvMom; + AMinvMom += par.a0[i]*MinvMom[i]; + + LapStencil.M(AMinvMom, Gtemp2); LMinvAMom=fac*Gtemp2; + LapStencil.M(MinvGMom, Gtemp2); temp=fac*Gtemp2; + MinvAGMom = par.a1[i]*temp; + MinvAGMom += par.a0[i]*MinvGMom; + LapStencil.M(MinvAGMom, Gtemp2); LMinvAGMom=fac*Gtemp2; + + + GaugeField tempDer(left.Grid()); + std::cout< class TrivialMetric : public Metric{ public: +// TrivialMetric(){this->triv=1;printf("TrivialMetric::triv=%d\n",this->Trivial());} virtual void ImportGauge(const Field&){}; virtual void M(const Field& in, Field& out){ +// printf("M:norm=%0.15e\n",norm2(in)); + std::cout << GridLogIntegrator << " M:norm(in)= " << std::sqrt(norm2(in)) << std::endl; out = in; } virtual void Minv(const Field& in, Field& out){ + std::cout << GridLogIntegrator << " Minv:norm(in)= " << std::sqrt(norm2(in)) << std::endl; out = in; } virtual void MSquareRoot(Field& P){ + std::cout << GridLogIntegrator << " MSquareRoot:norm(P)= " << std::sqrt(norm2(P)) << std::endl; // do nothing } virtual void MInvSquareRoot(Field& P){ + std::cout << GridLogIntegrator << " MInvSquareRoot:norm(P)= " << std::sqrt(norm2(P)) << std::endl; // do nothing } virtual void MDeriv(const Field& in, Field& out){ + std::cout << GridLogIntegrator << " MDeriv:norm(in)= " << std::sqrt(norm2(in)) << std::endl; + out = Zero(); + } + virtual void MinvDeriv(const Field& in, Field& out){ + std::cout << GridLogIntegrator << " MinvDeriv:norm(in)= " << std::sqrt(norm2(in)) << std::endl; out = Zero(); } virtual void MDeriv(const Field& left, const Field& right, Field& out){ + std::cout << GridLogIntegrator << " MDeriv:norm(left)= " << std::sqrt(norm2(left)) << std::endl; + std::cout << GridLogIntegrator << " MDeriv:norm(right)= " << std::sqrt(norm2(right)) << std::endl; out = Zero(); } @@ -101,14 +122,15 @@ public: // Generate gaussian momenta Implementation::generate_momenta(Mom, sRNG, pRNG); // Modify the distribution with the metric +// if(M.Trivial()) return; M.MSquareRoot(Mom); if (1) { // Auxiliary momenta // do nothing if trivial, so hide in the metric MomentaField AuxMomTemp(Mom.Grid()); - Implementation::generate_momenta(AuxMom, sRNG, pRNG); - Implementation::generate_momenta(AuxField, sRNG, pRNG); + Implementation::generate_momenta(AuxMom, sRNG,pRNG); + Implementation::generate_momenta(AuxField, sRNG,pRNG); // Modify the distribution with the metric // Aux^dag M Aux M.MInvSquareRoot(AuxMom); // AuxMom = M^{-1/2} AuxMomTemp @@ -117,11 +139,12 @@ public: // Correct RealD MomentaAction(){ + static RealD Saux=0.,Smom=0.; MomentaField inv(Mom.Grid()); inv = Zero(); M.Minv(Mom, inv); - LatticeComplex Hloc(Mom.Grid()); - Hloc = Zero(); + LatticeComplex Hloc(Mom.Grid()); Hloc = Zero(); + LatticeComplex Hloc2(Mom.Grid()); Hloc2 = Zero(); for (int mu = 0; mu < Nd; mu++) { // This is not very general // hide in the metric @@ -129,8 +152,15 @@ public: auto inv_mu = PeekIndex(inv, mu); Hloc += trace(Mom_mu * inv_mu); } + auto Htmp1 = TensorRemove(sum(Hloc)); + std::cout << GridLogMessage << "S:dSmom = " << Htmp1.real()-Smom << "\n"; + Smom=Htmp1.real()/HMC_MOMENTUM_DENOMINATOR; + - if (1) { + + +// if(!M.Trivial()) + { // Auxiliary Fields // hide in the metric M.M(AuxMom, inv); @@ -140,13 +170,18 @@ public: auto inv_mu = PeekIndex(inv, mu); auto am_mu = PeekIndex(AuxMom, mu); auto af_mu = PeekIndex(AuxField, mu); - Hloc += trace(am_mu * inv_mu);// p M p - Hloc += trace(af_mu * af_mu); + Hloc += trace(am_mu * inv_mu); + Hloc2 += trace(af_mu * af_mu); } } + auto Htmp2 = TensorRemove(sum(Hloc))-Htmp1; + std::cout << GridLogMessage << "S:dSaux = " << Htmp2.real()-Saux << "\n"; + Saux=Htmp2.real(); - auto Hsum = TensorRemove(sum(Hloc)); - return Hsum.real(); + auto Hsum = TensorRemove(sum(Hloc))/HMC_MOMENTUM_DENOMINATOR; + auto Hsum2 = TensorRemove(sum(Hloc2)); + std::cout << GridLogIntegrator << "MomentaAction: " << Hsum.real()+Hsum2.real() << std::endl; + return Hsum.real()+Hsum2.real(); } // Correct @@ -157,15 +192,17 @@ public: MomentaField MDer(in.Grid()); MomentaField X(in.Grid()); X = Zero(); - M.Minv(in, X); // X = G in - M.MDeriv(X, MDer); // MDer = U * dS/dU - der = Implementation::projectForce(MDer); // Ta if gauge fields + M.MinvDeriv(in, MDer); // MDer = U * dS/dU + der = -1.0* Implementation::projectForce(MDer); // Ta if gauge fields +// std::cout << GridLogIntegrator << " DerivativeU: norm(in)= " << std::sqrt(norm2(in)) << std::endl; +// std::cout << GridLogIntegrator << " DerivativeU: norm(der)= " << std::sqrt(norm2(der)) << std::endl; } void AuxiliaryFieldsDerivative(MomentaField& der){ der = Zero(); - if (1){ +// if(!M.Trivial()) + { // Auxiliary fields MomentaField der_temp(der.Grid()); MomentaField X(der.Grid()); @@ -173,6 +210,7 @@ public: //M.M(AuxMom, X); // X = M Aux // Two derivative terms // the Mderiv need separation of left and right terms + std::cout << GridLogIntegrator << " AuxiliaryFieldsDerivative:norm(AuxMom)= " << std::sqrt(norm2(AuxMom)) << std::endl; M.MDeriv(AuxMom, der); @@ -180,6 +218,7 @@ public: //M.MDeriv(X, AuxMom, der_temp); der += der_temp; der = -1.0*Implementation::projectForce(der); + std::cout << GridLogIntegrator << " AuxiliaryFieldsDerivative:norm(der)= " << std::sqrt(norm2(der)) << std::endl; } } @@ -189,22 +228,27 @@ public: // is the projection necessary here? // no for fields in the algebra der = Implementation::projectForce(der); + std::cout << GridLogIntegrator << " DerivativeP:norm(der)= " << std::sqrt(norm2(der)) << std::endl; } void update_auxiliary_momenta(RealD ep){ - if(1){ - AuxMom -= ep * AuxField; +// if(!M.Trivial()) + { + AuxMom -= ep * AuxField * HMC_MOMENTUM_DENOMINATOR; + std::cout << GridLogIntegrator << "AuxMom update_auxiliary_fields: " << std::sqrt(norm2(AuxMom)) << std::endl; } } void update_auxiliary_fields(RealD ep){ - if (1) { +// if(!M.Trivial()) + { MomentaField tmp(AuxMom.Grid()); MomentaField tmp2(AuxMom.Grid()); M.M(AuxMom, tmp); // M.M(tmp, tmp2); AuxField += ep * tmp; // M^2 AuxMom // factor of 2? + std::cout << GridLogIntegrator << "AuxField update_auxiliary_fields: " << std::sqrt(norm2(AuxField)) << std::endl; } } diff --git a/HMC/Mobius2p1p1fEOFA_4Gev.cc b/HMC/Mobius2p1p1fEOFA_4Gev.cc new file mode 100644 index 00000000..02065a0c --- /dev/null +++ b/HMC/Mobius2p1p1fEOFA_4Gev.cc @@ -0,0 +1,572 @@ +/************************************************************************************* + +Grid physics library, www.github.com/paboyle/Grid + +Source file: + +Copyright (C) 2015-2016 + +Author: Peter Boyle +Author: Guido Cossu +Author: David Murphy +Author: Chulwoo Jung + +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 + +#ifdef GRID_DEFAULT_PRECISION_DOUBLE +#define MIXED_PRECISION +#endif +// second level EOFA +#undef EOFA_H +#define USE_OBC +#undef DO_IMPLICIT + +NAMESPACE_BEGIN(Grid); + + /* + * Need a plan for gauge field update for mixed precision in HMC (2x speed up) + * -- Store the single prec action operator. + * -- Clone the gauge field from the operator function argument. + * -- Build the mixed precision operator dynamically from the passed operator and single prec clone. + */ + + template + class MixedPrecisionConjugateGradientOperatorFunction : public OperatorFunction { + public: + typedef typename FermionOperatorD::FermionField FieldD; + typedef typename FermionOperatorF::FermionField FieldF; + + using OperatorFunction::operator(); + + RealD Tolerance; + RealD InnerTolerance; //Initial tolerance for inner CG. Defaults to Tolerance but can be changed + Integer MaxInnerIterations; + Integer MaxOuterIterations; + GridBase* SinglePrecGrid4; //Grid for single-precision fields + GridBase* SinglePrecGrid5; //Grid for single-precision fields + RealD OuterLoopNormMult; //Stop the outer loop and move to a final double prec solve when the residual is OuterLoopNormMult * Tolerance + + FermionOperatorF &FermOpF; + FermionOperatorD &FermOpD;; + SchurOperatorF &LinOpF; + SchurOperatorD &LinOpD; + + Integer TotalInnerIterations; //Number of inner CG iterations + Integer TotalOuterIterations; //Number of restarts + Integer TotalFinalStepIterations; //Number of CG iterations in final patch-up step + + MixedPrecisionConjugateGradientOperatorFunction(RealD tol, + Integer maxinnerit, + Integer maxouterit, + GridBase* _sp_grid4, + GridBase* _sp_grid5, + FermionOperatorF &_FermOpF, + FermionOperatorD &_FermOpD, + SchurOperatorF &_LinOpF, + SchurOperatorD &_LinOpD): + LinOpF(_LinOpF), + LinOpD(_LinOpD), + FermOpF(_FermOpF), + FermOpD(_FermOpD), + Tolerance(tol), + InnerTolerance(tol), + MaxInnerIterations(maxinnerit), + MaxOuterIterations(maxouterit), + SinglePrecGrid4(_sp_grid4), + SinglePrecGrid5(_sp_grid5), + OuterLoopNormMult(100.) + { + /* Debugging instances of objects; references are stored + std::cout << GridLogMessage << " Mixed precision CG wrapper LinOpF " < &LinOpU, const FieldD &src, FieldD &psi) { + + std::cout << GridLogMessage << " Mixed precision CG wrapper operator() "<(&LinOpU); + + // std::cout << GridLogMessage << " Mixed precision CG wrapper operator() FermOpU " <_Mat)<_Mat)==&(LinOpD._Mat)); + + //////////////////////////////////////////////////////////////////////////////////// + // Must snarf a single precision copy of the gauge field in Linop_d argument + //////////////////////////////////////////////////////////////////////////////////// + typedef typename FermionOperatorF::GaugeField GaugeFieldF; + typedef typename FermionOperatorF::GaugeLinkField GaugeLinkFieldF; + typedef typename FermionOperatorD::GaugeField GaugeFieldD; + typedef typename FermionOperatorD::GaugeLinkField GaugeLinkFieldD; + + GridBase * GridPtrF = SinglePrecGrid4; + GridBase * GridPtrD = FermOpD.Umu.Grid(); + GaugeFieldF U_f (GridPtrF); + GaugeLinkFieldF Umu_f(GridPtrF); + // std::cout << " Dim gauge field "<Nd()<Nd()<(FermOpD.Umu, mu); + precisionChange(Umu_f,Umu_d); + PokeIndex(FermOpF.Umu, Umu_f, mu); + } + pickCheckerboard(Even,FermOpF.UmuEven,FermOpF.Umu); + pickCheckerboard(Odd ,FermOpF.UmuOdd ,FermOpF.Umu); + + //////////////////////////////////////////////////////////////////////////////////// + // Make a mixed precision conjugate gradient + //////////////////////////////////////////////////////////////////////////////////// + MixedPrecisionConjugateGradient MPCG(Tolerance,MaxInnerIterations,MaxOuterIterations,SinglePrecGrid5,LinOpF,LinOpD); + std::cout << GridLogMessage << "Calling mixed precision Conjugate Gradient" < HMCWrapper; +// typedef GenericHMCRunner HMCWrapper; +#ifdef DO_IMPLICIT + typedef GenericHMCRunner HMCWrapper; + HMCparams.MD.name =std::string("ImplicitMinimumNorm2"); +#else + typedef GenericHMCRunner HMCWrapper; +// typedef GenericHMCRunner HMCWrapper; + HMCparams.MD.name =std::string("ForceGradient"); +#endif + + std::cout << GridLogMessage<< HMCparams < PlaqObs; + TheHMC.Resources.AddObservable(); + ////////////////////////////////////////////// + + const int Ls = 12; + Real beta = 5.983; + std::cout << GridLogMessage << " beta "<< beta << std::endl; + Real light_mass = 0.00049; + Real strange_mass = 0.0158; + Real charm_mass = 0.191; + Real pv_mass = 1.0; + RealD M5 = 1.4; + RealD b = 2.0; + RealD c = 1.0; + + // Copied from paper +// std::vector hasenbusch({ 0.045 }); // Paper values from F1 incorrect run + std::vector hasenbusch({ 0.0038, 0.0145, 0.045, 0.108 , 0.25, 0.51 }); // Paper values from F1 incorrect run + std::vector hasenbusch2({ 0.4 }); // Paper values from F1 incorrect run + +// RealD eofa_mass=0.05 ; + + /////////////////////////////////////////////////////////////////////////////////////////////// + //Bad choices with large dH. Equalising force L2 norm was not wise. + /////////////////////////////////////////////////////////////////////////////////////////////// + //std::vector hasenbusch({ 0.03, 0.2, 0.3, 0.5, 0.8 }); + + auto GridPtr = TheHMC.Resources.GetCartesian(); + auto GridRBPtr = TheHMC.Resources.GetRBCartesian(); + auto FGrid = SpaceTimeGrid::makeFiveDimGrid(Ls,GridPtr); + auto FrbGrid = SpaceTimeGrid::makeFiveDimRedBlackGrid(Ls,GridPtr); + + Coordinate latt = GridDefaultLatt(); + Coordinate mpi = GridDefaultMpi(); + Coordinate simdF = GridDefaultSimd(Nd,vComplexF::Nsimd()); + Coordinate simdD = GridDefaultSimd(Nd,vComplexD::Nsimd()); + auto GridPtrF = SpaceTimeGrid::makeFourDimGrid(latt,simdF,mpi); + auto GridRBPtrF = SpaceTimeGrid::makeFourDimRedBlackGrid(GridPtrF); + auto FGridF = SpaceTimeGrid::makeFiveDimGrid(Ls,GridPtrF); + auto FrbGridF = SpaceTimeGrid::makeFiveDimRedBlackGrid(Ls,GridPtrF); + + +#ifndef USE_OBC +// IwasakiGaugeActionR GaugeAction(beta); + WilsonGaugeActionR GaugeAction(beta); +#else + std::vector boundaryG = {1,1,1,0}; + WilsonGaugeActionR::ImplParams ParamsG(boundaryG); + WilsonGaugeActionR GaugeAction(beta,ParamsG); +#endif + + // temporarily need a gauge field + LatticeGaugeField U(GridPtr); + LatticeGaugeFieldF UF(GridPtrF); + + // These lines are unecessary if BC are all periodic +#ifndef USE_OBC + std::vector boundary = {1,1,1,-1}; +#else + std::vector boundary = {1,1,1,0}; +#endif + FermionAction::ImplParams Params(boundary); + FermionActionF::ImplParams ParamsF(boundary); + + double ActionStoppingCondition = 1e-8; + double DerivativeStoppingCondition = 1e-6; + double MaxCGIterations = 30000; + + //////////////////////////////////// + // Collect actions + //////////////////////////////////// + ActionLevel Level1(1); + ActionLevel Level2(HMCparams.SW); + + //////////////////////////////////// + // Strange action + //////////////////////////////////// + typedef SchurDiagMooeeOperator LinearOperatorF; + typedef SchurDiagMooeeOperator LinearOperatorD; + typedef SchurDiagMooeeOperator LinearOperatorEOFAF; + typedef SchurDiagMooeeOperator LinearOperatorEOFAD; + + typedef MixedPrecisionConjugateGradientOperatorFunction MxPCG; + typedef MixedPrecisionConjugateGradientOperatorFunction MxPCG_EOFA; + + // DJM: setup for EOFA ratio (Mobius) + OneFlavourRationalParams OFRp; + OFRp.lo = 0.99; // How do I know this on F1? + OFRp.hi = 20; + OFRp.MaxIter = 100000; + OFRp.tolerance= 1.0e-12; + OFRp.degree = 12; + OFRp.precision= 50; + + + MobiusEOFAFermionD Strange_Op_L (U , *FGrid , *FrbGrid , *GridPtr , *GridRBPtr , strange_mass, strange_mass, charm_mass, 0.0, -1, M5, b, c); + MobiusEOFAFermionF Strange_Op_LF(UF, *FGridF, *FrbGridF, *GridPtrF, *GridRBPtrF, strange_mass, strange_mass, charm_mass, 0.0, -1, M5, b, c); + MobiusEOFAFermionD Strange_Op_R (U , *FGrid , *FrbGrid , *GridPtr , *GridRBPtr , charm_mass, strange_mass, charm_mass, -1.0, 1, M5, b, c); + MobiusEOFAFermionF Strange_Op_RF(UF, *FGridF, *FrbGridF, *GridPtrF, *GridRBPtrF, charm_mass, strange_mass, charm_mass, -1.0, 1, M5, b, c); + +#ifdef EOFA_H + MobiusEOFAFermionD Strange2_Op_L (U , *FGrid , *FrbGrid , *GridPtr , *GridRBPtr , eofa_mass, eofa_mass, charm_mass , 0.0, -1, M5, b, c); + MobiusEOFAFermionF Strange2_Op_LF(UF, *FGridF, *FrbGridF, *GridPtrF, *GridRBPtrF, eofa_mass, eofa_mass, charm_mass , 0.0, -1, M5, b, c); + MobiusEOFAFermionD Strange2_Op_R (U , *FGrid , *FrbGrid , *GridPtr , *GridRBPtr , charm_mass , eofa_mass, charm_mass , -1.0, 1, M5, b, c); + MobiusEOFAFermionF Strange2_Op_RF(UF, *FGridF, *FrbGridF, *GridPtrF, *GridRBPtrF, charm_mass , eofa_mass, charm_mass , -1.0, 1, M5, b, c); +#endif + + ConjugateGradient ActionCG(ActionStoppingCondition,MaxCGIterations); + ConjugateGradient DerivativeCG(DerivativeStoppingCondition,MaxCGIterations); +#ifdef MIXED_PRECISION + const int MX_inner = 5000; + + // Mixed precision EOFA + LinearOperatorEOFAD Strange_LinOp_L (Strange_Op_L); + LinearOperatorEOFAD Strange_LinOp_R (Strange_Op_R); + LinearOperatorEOFAF Strange_LinOp_LF(Strange_Op_LF); + LinearOperatorEOFAF Strange_LinOp_RF(Strange_Op_RF); + +#ifdef EOFA_H + // Mixed precision EOFA + LinearOperatorEOFAD Strange2_LinOp_L (Strange2_Op_L); + LinearOperatorEOFAD Strange2_LinOp_R (Strange2_Op_R); + LinearOperatorEOFAF Strange2_LinOp_LF(Strange2_Op_LF); + LinearOperatorEOFAF Strange2_LinOp_RF(Strange2_Op_RF); +#endif + + MxPCG_EOFA ActionCGL(ActionStoppingCondition, + MX_inner, + MaxCGIterations, + GridPtrF, + FrbGridF, + Strange_Op_LF,Strange_Op_L, + Strange_LinOp_LF,Strange_LinOp_L); + +#ifdef EOFA_H + MxPCG_EOFA ActionCGL2(ActionStoppingCondition, + MX_inner, + MaxCGIterations, + GridPtrF, + FrbGridF, + Strange2_Op_LF,Strange2_Op_L, + Strange2_LinOp_LF,Strange2_LinOp_L); +#endif + + MxPCG_EOFA DerivativeCGL(DerivativeStoppingCondition, + MX_inner, + MaxCGIterations, + GridPtrF, + FrbGridF, + Strange_Op_LF,Strange_Op_L, + Strange_LinOp_LF,Strange_LinOp_L); + +#ifdef EOFA_H + MxPCG_EOFA DerivativeCGL2(DerivativeStoppingCondition, + MX_inner, + MaxCGIterations, + GridPtrF, + FrbGridF, + Strange2_Op_LF,Strange2_Op_L, + Strange2_LinOp_LF,Strange2_LinOp_L); +#endif + + MxPCG_EOFA ActionCGR(ActionStoppingCondition, + MX_inner, + MaxCGIterations, + GridPtrF, + FrbGridF, + Strange_Op_RF,Strange_Op_R, + Strange_LinOp_RF,Strange_LinOp_R); + +#ifdef EOFA_H + MxPCG_EOFA ActionCGR2(ActionStoppingCondition, + MX_inner, + MaxCGIterations, + GridPtrF, + FrbGridF, + Strange2_Op_RF,Strange2_Op_R, + Strange2_LinOp_RF,Strange2_LinOp_R); +#endif + + MxPCG_EOFA DerivativeCGR(DerivativeStoppingCondition, + MX_inner, + MaxCGIterations, + GridPtrF, + FrbGridF, + Strange_Op_RF,Strange_Op_R, + Strange_LinOp_RF,Strange_LinOp_R); + +#ifdef EOFA_H + MxPCG_EOFA DerivativeCGR2(DerivativeStoppingCondition, + MX_inner, + MaxCGIterations, + GridPtrF, + FrbGridF, + Strange2_Op_RF,Strange2_Op_R, + Strange2_LinOp_RF,Strange2_LinOp_R); +#endif + + ExactOneFlavourRatioPseudoFermionAction + EOFA(Strange_Op_L, Strange_Op_R, + ActionCG, + ActionCGL, ActionCGR, + DerivativeCGL, DerivativeCGR, + OFRp, true); + +#ifdef EOFA_H + ExactOneFlavourRatioPseudoFermionAction + EOFA2(Strange2_Op_L, Strange2_Op_R, + ActionCG, + ActionCGL2, ActionCGR2, + DerivativeCGL2, DerivativeCGR2, + OFRp, true); +#endif + + Level1.push_back(&EOFA); +#ifdef EOFA_H + Level1.push_back(&EOFA2); +#endif + +#else + ExactOneFlavourRatioPseudoFermionAction + EOFA(Strange_Op_L, Strange_Op_R, + ActionCG, + ActionCG, ActionCG, + ActionCG, ActionCG, + // DerivativeCG, DerivativeCG, + OFRp, true); + Level1.push_back(&EOFA); +#endif + + //////////////////////////////////// + // up down action + //////////////////////////////////// + std::vector light_den; + std::vector light_num; + + int n_hasenbusch = hasenbusch.size(); + light_den.push_back(light_mass); + for(int h=0;h Numerators; + std::vector Denominators; + std::vector *> Quotients; + std::vector ActionMPCG; + std::vector MPCG; + std::vector DenominatorsF; + std::vector LinOpD; + std::vector LinOpF; + + for(int h=0;h(*Numerators[h],*Denominators[h],*MPCG[h],*ActionMPCG[h],ActionCG)); +#else + //////////////////////////////////////////////////////////////////////////// + // Standard CG for 2f force + //////////////////////////////////////////////////////////////////////////// + Quotients.push_back (new TwoFlavourEvenOddRatioPseudoFermionAction(*Numerators[h],*Denominators[h],DerivativeCG,ActionCG)); +#endif + + } + + for(int h=0;h