From 83f818a99d75ed728502d9f5f701852bb3a4be84 Mon Sep 17 00:00:00 2001 From: Peter Boyle Date: Tue, 5 Apr 2022 16:24:34 -0400 Subject: [PATCH] Updates for DDHMC --- Grid/qcd/action/ActionParams.h | 5 +- Grid/qcd/action/fermion/CayleyFermion5D.h | 2 +- Grid/qcd/action/pseudofermion/Bounds.h | 25 ++ ...osedBoundaryTwoFlavourBosonPseudoFermion.h | 163 ++++++++++++ ...ecomposedBoundaryTwoFlavourPseudoFermion.h | 158 ++++++++++++ ...osedBoundaryTwoFlavourRatioPseudoFermion.h | 237 ++++++++++++++++++ .../OneFlavourEvenOddRationalRatio.h | 12 +- .../pseudofermion/OneFlavourRationalRatio.h | 20 +- .../pseudofermion/TwoFlavourEvenOddRatio.h | 8 +- .../TwoFlavourRatioEO4DPseudoFermion.h | 203 +++++++++++++++ Grid/qcd/hmc/integrators/Integrator.h | 1 + HMC/Mobius2p1f_DD_RHMC.cc | 95 ++++--- systems/Crusher/comms.slurm | 26 ++ 13 files changed, 911 insertions(+), 44 deletions(-) create mode 100644 Grid/qcd/action/pseudofermion/DomainDecomposedBoundaryTwoFlavourBosonPseudoFermion.h create mode 100644 Grid/qcd/action/pseudofermion/DomainDecomposedBoundaryTwoFlavourPseudoFermion.h create mode 100644 Grid/qcd/action/pseudofermion/DomainDecomposedBoundaryTwoFlavourRatioPseudoFermion.h create mode 100644 Grid/qcd/action/pseudofermion/TwoFlavourRatioEO4DPseudoFermion.h create mode 100644 systems/Crusher/comms.slurm diff --git a/Grid/qcd/action/ActionParams.h b/Grid/qcd/action/ActionParams.h index 0e6a11c6..6a3f053a 100644 --- a/Grid/qcd/action/ActionParams.h +++ b/Grid/qcd/action/ActionParams.h @@ -63,6 +63,7 @@ struct StaggeredImplParams { RealD, hi, int, MaxIter, RealD, tolerance, + RealD, mdtolerance, int, degree, int, precision, int, BoundsCheckFreq); @@ -76,11 +77,13 @@ struct StaggeredImplParams { RealD tol = 1.0e-8, int _degree = 10, int _precision = 64, - int _BoundsCheckFreq=20) + int _BoundsCheckFreq=20, + RealD mdtol = 1.0e-6) : lo(_lo), hi(_hi), MaxIter(_maxit), tolerance(tol), + mdtolerance(mdtol), degree(_degree), precision(_precision), BoundsCheckFreq(_BoundsCheckFreq){}; diff --git a/Grid/qcd/action/fermion/CayleyFermion5D.h b/Grid/qcd/action/fermion/CayleyFermion5D.h index c7d68d73..489b51ff 100644 --- a/Grid/qcd/action/fermion/CayleyFermion5D.h +++ b/Grid/qcd/action/fermion/CayleyFermion5D.h @@ -68,7 +68,7 @@ public: /////////////////////////////////////////////////////////////// // Support for MADWF tricks /////////////////////////////////////////////////////////////// - RealD Mass(void) { return mass; }; + virtual RealD Mass(void) { return mass; }; void SetMass(RealD _mass) { mass=_mass; SetCoefficientsInternal(_zolo_hi,_gamma,_b,_c); // Reset coeffs diff --git a/Grid/qcd/action/pseudofermion/Bounds.h b/Grid/qcd/action/pseudofermion/Bounds.h index 535e1a49..b9621f24 100644 --- a/Grid/qcd/action/pseudofermion/Bounds.h +++ b/Grid/qcd/action/pseudofermion/Bounds.h @@ -13,6 +13,31 @@ NAMESPACE_BEGIN(Grid); std::cout << GridLogMessage << "Pseudofermion action lamda_max "< void ChebyBoundsCheck(LinearOperatorBase &HermOp, + Field &GaussNoise, + RealD lo,RealD hi) + { + int orderfilter = 1000; + Chebyshev Cheb(lo,hi,orderfilter); + + GridBase *FermionGrid = GaussNoise.Grid(); + + Field X(FermionGrid); + Field Z(FermionGrid); + + X=GaussNoise; + RealD Nx = norm2(X); + Cheb(HermOp,X,Z); + RealD Nz = norm2(Z); + + std::cout << "************************* "< void InverseSqrtBoundsCheck(int MaxIter,double tol, LinearOperatorBase &HermOp, diff --git a/Grid/qcd/action/pseudofermion/DomainDecomposedBoundaryTwoFlavourBosonPseudoFermion.h b/Grid/qcd/action/pseudofermion/DomainDecomposedBoundaryTwoFlavourBosonPseudoFermion.h new file mode 100644 index 00000000..d00ae894 --- /dev/null +++ b/Grid/qcd/action/pseudofermion/DomainDecomposedBoundaryTwoFlavourBosonPseudoFermion.h @@ -0,0 +1,163 @@ +/************************************************************************************* + + Grid physics library, www.github.com/paboyle/Grid + + Source file: ./lib/qcd/action/pseudofermion/DomainDecomposedTwoFlavourBoundaryBoson.h + + Copyright (C) 2021 + +Author: Peter Boyle + + This program is free software; you can redistribute it and/or modify + it under the terms of the GNU General Public License as published by + the Free Software Foundation; either version 2 of the License, or + (at your option) any later version. + + This program is distributed in the hope that it will be useful, + but WITHOUT ANY WARRANTY; without even the implied warranty of + MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the + GNU General Public License for more details. + + You should have received a copy of the GNU General Public License along + with this program; if not, write to the Free Software Foundation, Inc., + 51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. + + See the full license in the file "LICENSE" in the top level distribution directory +*************************************************************************************/ +/* END LEGAL */ +#pragma once + +NAMESPACE_BEGIN(Grid); + +/////////////////////////////////////// +// Two flavour ratio +/////////////////////////////////////// +template +class DomainDecomposedBoundaryTwoFlavourBosonPseudoFermion : public Action { +public: + INHERIT_IMPL_TYPES(ImplD); + +private: + SchurFactoredFermionOperator & NumOp;// the basic operator + RealD InnerStoppingCondition; + RealD ActionStoppingCondition; + RealD DerivativeStoppingCondition; + FermionField Phi; // the pseudo fermion field for this trajectory +public: + DomainDecomposedBoundaryTwoFlavourBosonPseudoFermion(SchurFactoredFermionOperator &_NumOp,RealD _DerivativeTol, RealD _ActionTol, RealD _InnerTol=1.0e-6) + : NumOp(_NumOp), + DerivativeStoppingCondition(_DerivativeTol), + ActionStoppingCondition(_ActionTol), + InnerStoppingCondition(_InnerTol), + Phi(_NumOp.FermionGrid()) {}; + + virtual std::string action_name(){return "DomainDecomposedBoundaryTwoFlavourBosonPseudoFermion";} + + virtual std::string LogParameters(){ + std::stringstream sstream; + return sstream.str(); + } + + virtual void refresh(const GaugeField &U, GridSerialRNG& sRNG, GridParallelRNG& pRNG) + { + // P(phi) = e^{- phi^dag P^dag P phi} + // + // NumOp == P + // + // Take phi = P^{-1} eta ; eta = P Phi + // + // P(eta) = e^{- eta^dag eta} + // + // e^{x^2/2 sig^2} => sig^2 = 0.5. + // + // So eta should be of width sig = 1/sqrt(2) and must multiply by 0.707.... + // + RealD scale = std::sqrt(0.5); + + NumOp.tolinner=InnerStoppingCondition; + NumOp.tol=ActionStoppingCondition; + NumOp.ImportGauge(U); + + FermionField eta(NumOp.FermionGrid()); + + gaussian(pRNG,eta); eta=eta*scale; + + NumOp.ProjectBoundaryBar(eta); + //DumpSliceNorm("eta",eta); + NumOp.RInv(eta,Phi); + + //DumpSliceNorm("Phi",Phi); + + }; + + ////////////////////////////////////////////////////// + // S = phi^dag Pdag P phi + ////////////////////////////////////////////////////// + virtual RealD S(const GaugeField &U) { + + NumOp.tolinner=InnerStoppingCondition; + NumOp.tol=ActionStoppingCondition; + NumOp.ImportGauge(U); + + FermionField Y(NumOp.FermionGrid()); + + NumOp.R(Phi,Y); + + RealD action = norm2(Y); + + return action; + }; + + virtual void deriv(const GaugeField &U,GaugeField & dSdU) + { + NumOp.tolinner=InnerStoppingCondition; + NumOp.tol=DerivativeStoppingCondition; + NumOp.ImportGauge(U); + + GridBase *fgrid = NumOp.FermionGrid(); + GridBase *ugrid = NumOp.GaugeGrid(); + + FermionField X(fgrid); + FermionField Y(fgrid); + FermionField tmp(fgrid); + + GaugeField force(ugrid); + + FermionField DobiDdbPhi(fgrid); // Vector A in my notes + FermionField DoiDdDobiDdbPhi(fgrid); // Vector B in my notes + FermionField DoidP_Phi(fgrid); // Vector E in my notes + FermionField DobidDddDoidP_Phi(fgrid); // Vector F in my notes + + FermionField P_Phi(fgrid); + + // P term + NumOp.dBoundaryBar(Phi,tmp); + NumOp.dOmegaBarInv(tmp,DobiDdbPhi); // Vector A + NumOp.dBoundary(DobiDdbPhi,tmp); + NumOp.dOmegaInv(tmp,DoiDdDobiDdbPhi); // Vector B + P_Phi = Phi - DoiDdDobiDdbPhi; + NumOp.ProjectBoundaryBar(P_Phi); + + // P^dag P term + NumOp.dOmegaDagInv(P_Phi,DoidP_Phi); // Vector E + NumOp.dBoundaryDag(DoidP_Phi,tmp); + NumOp.dOmegaBarDagInv(tmp,DobidDddDoidP_Phi); // Vector F + NumOp.dBoundaryBarDag(DobidDddDoidP_Phi,tmp); + + X = DobiDdbPhi; + Y = DobidDddDoidP_Phi; + NumOp.DirichletFermOpD.MDeriv(force,Y,X,DaggerNo); dSdU=force; + NumOp.DirichletFermOpD.MDeriv(force,X,Y,DaggerYes); dSdU=dSdU+force; + + X = DoiDdDobiDdbPhi; + Y = DoidP_Phi; + NumOp.DirichletFermOpD.MDeriv(force,Y,X,DaggerNo); dSdU=dSdU+force; + NumOp.DirichletFermOpD.MDeriv(force,X,Y,DaggerYes); dSdU=dSdU+force; + + dSdU *= -1.0; + + }; +}; + +NAMESPACE_END(Grid); + diff --git a/Grid/qcd/action/pseudofermion/DomainDecomposedBoundaryTwoFlavourPseudoFermion.h b/Grid/qcd/action/pseudofermion/DomainDecomposedBoundaryTwoFlavourPseudoFermion.h new file mode 100644 index 00000000..1f3687ca --- /dev/null +++ b/Grid/qcd/action/pseudofermion/DomainDecomposedBoundaryTwoFlavourPseudoFermion.h @@ -0,0 +1,158 @@ +/************************************************************************************* + + Grid physics library, www.github.com/paboyle/Grid + + Source file: ./lib/qcd/action/pseudofermion/DomainDecomposedTwoFlavourBoundary.h + + Copyright (C) 2021 + +Author: Peter Boyle + + This program is free software; you can redistribute it and/or modify + it under the terms of the GNU General Public License as published by + the Free Software Foundation; either version 2 of the License, or + (at your option) any later version. + + This program is distributed in the hope that it will be useful, + but WITHOUT ANY WARRANTY; without even the implied warranty of + MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the + GNU General Public License for more details. + + You should have received a copy of the GNU General Public License along + with this program; if not, write to the Free Software Foundation, Inc., + 51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. + + See the full license in the file "LICENSE" in the top level distribution directory +*************************************************************************************/ +/* END LEGAL */ +#pragma once + +NAMESPACE_BEGIN(Grid); + +/////////////////////////////////////// +// Two flavour ratio +/////////////////////////////////////// +template +class DomainDecomposedBoundaryTwoFlavourPseudoFermion : public Action { +public: + INHERIT_IMPL_TYPES(ImplD); + +private: + SchurFactoredFermionOperator & DenOp;// the basic operator + RealD ActionStoppingCondition; + RealD DerivativeStoppingCondition; + RealD InnerStoppingCondition; + + FermionField Phi; // the pseudo fermion field for this trajectory + + RealD refresh_action; +public: + DomainDecomposedBoundaryTwoFlavourPseudoFermion(SchurFactoredFermionOperator &_DenOp,RealD _DerivativeTol, RealD _ActionTol, RealD _InnerTol = 1.0e-6 ) + : DenOp(_DenOp), + DerivativeStoppingCondition(_DerivativeTol), + ActionStoppingCondition(_ActionTol), + InnerStoppingCondition(_InnerTol), + Phi(_DenOp.FermionGrid()) {}; + + virtual std::string action_name(){return "DomainDecomposedBoundaryTwoFlavourPseudoFermion";} + + + virtual std::string LogParameters(){ + std::stringstream sstream; + return sstream.str(); + } + + virtual void refresh(const GaugeField &U, GridSerialRNG& sRNG, GridParallelRNG& pRNG) + { + // P(phi) = e^{- phi^dag Rdag^-1 R^-1 phi} + // + // DenOp == R + // + // Take phi = R eta ; eta = R^-1 Phi + // + // P(eta) = e^{- eta^dag eta} + // + // e^{x^2/2 sig^2} => sig^2 = 0.5. + // + // So eta should be of width sig = 1/sqrt(2) and must multiply by 0.707.... + // + RealD scale = std::sqrt(0.5); + + DenOp.tolinner=InnerStoppingCondition; + DenOp.tol =ActionStoppingCondition; + DenOp.ImportGauge(U); + + FermionField eta(DenOp.FermionGrid()); + + gaussian(pRNG,eta); eta=eta*scale; + + DenOp.ProjectBoundaryBar(eta); + DenOp.R(eta,Phi); + //DumpSliceNorm("Phi",Phi); + refresh_action = norm2(eta); + }; + + ////////////////////////////////////////////////////// + // S = phi^dag Rdag^-1 R^-1 phi + ////////////////////////////////////////////////////// + virtual RealD S(const GaugeField &U) { + + DenOp.tolinner=InnerStoppingCondition; + DenOp.tol=ActionStoppingCondition; + DenOp.ImportGauge(U); + + FermionField X(DenOp.FermionGrid()); + + DenOp.RInv(Phi,X); + + RealD action = norm2(X); + + return action; + }; + + virtual void deriv(const GaugeField &U,GaugeField & dSdU) + { + DenOp.tolinner=InnerStoppingCondition; + DenOp.tol=DerivativeStoppingCondition; + DenOp.ImportGauge(U); + + GridBase *fgrid = DenOp.FermionGrid(); + GridBase *ugrid = DenOp.GaugeGrid(); + + FermionField X(fgrid); + FermionField Y(fgrid); + FermionField tmp(fgrid); + + GaugeField force(ugrid); + + FermionField DiDdb_Phi(fgrid); // Vector C in my notes + FermionField DidRinv_Phi(fgrid); // Vector D in my notes + FermionField Rinv_Phi(fgrid); + +// FermionField RinvDagRinv_Phi(fgrid); +// FermionField DdbdDidRinv_Phi(fgrid); + + // R^-1 term + DenOp.dBoundaryBar(Phi,tmp); + DenOp.Dinverse(tmp,DiDdb_Phi); // Vector C + Rinv_Phi = Phi - DiDdb_Phi; + DenOp.ProjectBoundaryBar(Rinv_Phi); + + // R^-dagger R^-1 term + DenOp.DinverseDag(Rinv_Phi,DidRinv_Phi); // Vector D +/* + DenOp.dBoundaryBarDag(DidRinv_Phi,DdbdDidRinv_Phi); + RinvDagRinv_Phi = Rinv_Phi - DdbdDidRinv_Phi; + DenOp.ProjectBoundaryBar(RinvDagRinv_Phi); +*/ + X = DiDdb_Phi; + Y = DidRinv_Phi; + DenOp.PeriodicFermOpD.MDeriv(force,Y,X,DaggerNo); dSdU=force; + DenOp.PeriodicFermOpD.MDeriv(force,X,Y,DaggerYes); dSdU=dSdU+force; + DumpSliceNorm("force",dSdU); + dSdU *= -1.0; + }; +}; + +NAMESPACE_END(Grid); + diff --git a/Grid/qcd/action/pseudofermion/DomainDecomposedBoundaryTwoFlavourRatioPseudoFermion.h b/Grid/qcd/action/pseudofermion/DomainDecomposedBoundaryTwoFlavourRatioPseudoFermion.h new file mode 100644 index 00000000..cb9ce0a4 --- /dev/null +++ b/Grid/qcd/action/pseudofermion/DomainDecomposedBoundaryTwoFlavourRatioPseudoFermion.h @@ -0,0 +1,237 @@ +/************************************************************************************* + + Grid physics library, www.github.com/paboyle/Grid + + Source file: ./lib/qcd/action/pseudofermion/DomainDecomposedTwoFlavourBoundary.h + + Copyright (C) 2021 + +Author: Peter Boyle + + This program is free software; you can redistribute it and/or modify + it under the terms of the GNU General Public License as published by + the Free Software Foundation; either version 2 of the License, or + (at your option) any later version. + + This program is distributed in the hope that it will be useful, + but WITHOUT ANY WARRANTY; without even the implied warranty of + MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the + GNU General Public License for more details. + + You should have received a copy of the GNU General Public License along + with this program; if not, write to the Free Software Foundation, Inc., + 51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. + + See the full license in the file "LICENSE" in the top level distribution directory +*************************************************************************************/ +/* END LEGAL */ +#pragma once + +NAMESPACE_BEGIN(Grid); + +/////////////////////////////////////// +// Two flavour ratio +/////////////////////////////////////// +template +class DomainDecomposedBoundaryTwoFlavourRatioPseudoFermion : public Action { +public: + INHERIT_IMPL_TYPES(ImplD); + +private: + SchurFactoredFermionOperator & NumOp;// the basic operator + SchurFactoredFermionOperator & DenOp;// the basic operator + + RealD InnerStoppingCondition; + RealD ActionStoppingCondition; + RealD DerivativeStoppingCondition; + + FermionField Phi; // the pseudo fermion field for this trajectory + +public: + DomainDecomposedBoundaryTwoFlavourRatioPseudoFermion(SchurFactoredFermionOperator &_NumOp, + SchurFactoredFermionOperator &_DenOp, + RealD _DerivativeTol, RealD _ActionTol, RealD _InnerTol=1.0e-6) + : NumOp(_NumOp), DenOp(_DenOp), + Phi(_NumOp.PeriodicFermOpD.FermionGrid()), + InnerStoppingCondition(_InnerTol), + DerivativeStoppingCondition(_DerivativeTol), + ActionStoppingCondition(_ActionTol) + {}; + + virtual std::string action_name(){return "DomainDecomposedBoundaryTwoFlavourRatioPseudoFermion";} + + virtual std::string LogParameters(){ + std::stringstream sstream; + return sstream.str(); + } + + virtual void refresh(const GaugeField &U, GridSerialRNG& sRNG, GridParallelRNG& pRNG) + { + NumOp.ImportGauge(U); + DenOp.ImportGauge(U); + + FermionField eta(NumOp.PeriodicFermOpD.FermionGrid()); + FermionField tmp(NumOp.PeriodicFermOpD.FermionGrid()); + + // P(phi) = e^{- phi^dag P^dag Rdag^-1 R^-1 P phi} + // + // NumOp == P + // DenOp == R + // + // Take phi = P^{-1} R eta ; eta = R^-1 P Phi + // + // P(eta) = e^{- eta^dag eta} + // + // e^{x^2/2 sig^2} => sig^2 = 0.5. + // + // So eta should be of width sig = 1/sqrt(2) and must multiply by 0.707.... + // + RealD scale = std::sqrt(0.5); + + gaussian(pRNG,eta); eta=eta*scale; + + NumOp.ProjectBoundaryBar(eta); + NumOp.tolinner=InnerStoppingCondition; + DenOp.tolinner=InnerStoppingCondition; + DenOp.tol = ActionStoppingCondition; + NumOp.tol = ActionStoppingCondition; + DenOp.R(eta,tmp); + NumOp.RInv(tmp,Phi); + DumpSliceNorm("Phi",Phi); + + }; + + ////////////////////////////////////////////////////// + // S = phi^dag Pdag Rdag^-1 R^-1 P phi + ////////////////////////////////////////////////////// + virtual RealD S(const GaugeField &U) { + + NumOp.ImportGauge(U); + DenOp.ImportGauge(U); + + FermionField X(NumOp.PeriodicFermOpD.FermionGrid()); + FermionField Y(NumOp.PeriodicFermOpD.FermionGrid()); + + NumOp.tolinner=InnerStoppingCondition; + DenOp.tolinner=InnerStoppingCondition; + DenOp.tol = ActionStoppingCondition; + NumOp.tol = ActionStoppingCondition; + NumOp.R(Phi,Y); + DenOp.RInv(Y,X); + + RealD action = norm2(X); + // std::cout << " DD boundary action is " < & DenOp;// the basic operator FermionField PhiEven; // the pseudo fermion field for this trajectory FermionField PhiOdd; // the pseudo fermion field for this trajectory + FermionField Noise; // spare noise field for bounds check public: @@ -70,6 +71,7 @@ NAMESPACE_BEGIN(Grid); DenOp(_DenOp), PhiOdd (_NumOp.FermionRedBlackGrid()), PhiEven(_NumOp.FermionRedBlackGrid()), + Noise(_NumOp.FermionRedBlackGrid()), param(p) { AlgRemez remez(param.lo,param.hi,param.precision); @@ -87,7 +89,11 @@ NAMESPACE_BEGIN(Grid); PowerNegQuarter.Init(remez,param.tolerance,true); }; - virtual std::string action_name(){return "OneFlavourEvenOddRatioRationalPseudoFermionAction";} + virtual std::string action_name(){ + std::stringstream sstream; + sstream<< "OneFlavourEvenOddRatioRationalPseudoFermionAction det("<< DenOp.Mass() << ") / det("<Broadcast(0,r); if ( (r%param.BoundsCheckFreq)==0 ) { FermionField gauss(NumOp.FermionRedBlackGrid()); - gauss = PhiOdd; + gauss = Noise; HighBoundCheck(MdagM,gauss,param.hi); InverseSqrtBoundsCheck(param.MaxIter,param.tolerance*100,MdagM,gauss,PowerNegHalf); + ChebyBoundsCheck(MdagM,Noise,param.lo,param.hi); } // Phidag VdagV^1/4 MdagM^-1/4 MdagM^-1/4 VdagV^1/4 Phi diff --git a/Grid/qcd/action/pseudofermion/OneFlavourRationalRatio.h b/Grid/qcd/action/pseudofermion/OneFlavourRationalRatio.h index 128c869a..f8e2e703 100644 --- a/Grid/qcd/action/pseudofermion/OneFlavourRationalRatio.h +++ b/Grid/qcd/action/pseudofermion/OneFlavourRationalRatio.h @@ -49,10 +49,12 @@ NAMESPACE_BEGIN(Grid); Params param; MultiShiftFunction PowerHalf ; - MultiShiftFunction PowerNegHalf; MultiShiftFunction PowerQuarter; + MultiShiftFunction PowerNegHalf; MultiShiftFunction PowerNegQuarter; + MultiShiftFunction MDPowerQuarter; + MultiShiftFunction MDPowerNegHalf; private: FermionOperator & NumOp;// the basic operator @@ -79,6 +81,10 @@ NAMESPACE_BEGIN(Grid); remez.generateApprox(param.degree,1,4); PowerQuarter.Init(remez,param.tolerance,false); PowerNegQuarter.Init(remez,param.tolerance,true); + + // Derive solves different tol + MDPowerQuarter.Init(remez,param.mdtolerance,false); + MDPowerNegHalf.Init(remez,param.mdtolerance,true); }; virtual std::string action_name(){return "OneFlavourRatioRationalPseudoFermionAction";} @@ -204,8 +210,8 @@ NAMESPACE_BEGIN(Grid); virtual void deriv(const GaugeField &U,GaugeField & dSdU) { - const int n_f = PowerNegHalf.poles.size(); - const int n_pv = PowerQuarter.poles.size(); + const int n_f = MDPowerNegHalf.poles.size(); + const int n_pv = MDPowerQuarter.poles.size(); std::vector MpvPhi_k (n_pv,NumOp.FermionGrid()); std::vector MpvMfMpvPhi_k(n_pv,NumOp.FermionGrid()); @@ -224,8 +230,8 @@ NAMESPACE_BEGIN(Grid); MdagMLinearOperator ,FermionField> MdagM(DenOp); MdagMLinearOperator ,FermionField> VdagV(NumOp); - ConjugateGradientMultiShift msCG_V(param.MaxIter,PowerQuarter); - ConjugateGradientMultiShift msCG_M(param.MaxIter,PowerNegHalf); + ConjugateGradientMultiShift msCG_V(param.MaxIter,MDPowerQuarter); + ConjugateGradientMultiShift msCG_M(param.MaxIter,MDPowerNegHalf); msCG_V(VdagV,Phi,MpvPhi_k,MpvPhi); msCG_M(MdagM,MpvPhi,MfMpvPhi_k,MfMpvPhi); @@ -244,7 +250,7 @@ NAMESPACE_BEGIN(Grid); //(1) for(int k=0;k +Author: Peter Boyle +Author: paboyle + + This program is free software; you can redistribute it and/or modify + it under the terms of the GNU General Public License as published by + the Free Software Foundation; either version 2 of the License, or + (at your option) any later version. + + This program is distributed in the hope that it will be useful, + but WITHOUT ANY WARRANTY; without even the implied warranty of + MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the + GNU General Public License for more details. + + You should have received a copy of the GNU General Public License along + with this program; if not, write to the Free Software Foundation, Inc., + 51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. + + See the full license in the file "LICENSE" in the top level distribution directory +*************************************************************************************/ +/* END LEGAL */ +#pragma once + +NAMESPACE_BEGIN(Grid); + +/////////////////////////////////////// +// Two flavour ratio +/////////////////////////////////////// +template +class TwoFlavourRatioEO4DPseudoFermionAction : public Action { +public: + INHERIT_IMPL_TYPES(Impl); + +private: + typedef FermionOperator FermOp; + FermionOperator & NumOp;// the basic operator + FermionOperator & DenOp;// the basic operator + + OperatorFunction &DerivativeSolver; + OperatorFunction &DerivativeDagSolver; + OperatorFunction &ActionSolver; + OperatorFunction &HeatbathSolver; + + FermionField phi4; // the pseudo fermion field for this trajectory + +public: + TwoFlavourRatioEO4DPseudoFermionAction(FermionOperator &_NumOp, + FermionOperator &_DenOp, + OperatorFunction & DS, + OperatorFunction & AS ) : + TwoFlavourRatioEO4DPseudoFermionAction(_NumOp,_DenOp, DS,DS,AS,AS) {}; + TwoFlavourRatioEO4DPseudoFermionAction(FermionOperator &_NumOp, + FermionOperator &_DenOp, + OperatorFunction & DS, + OperatorFunction & DDS, + OperatorFunction & AS, + OperatorFunction & HS + ) : NumOp(_NumOp), + DenOp(_DenOp), + DerivativeSolver(DS), + DerivativeDagSolver(DDS), + ActionSolver(AS), + HeatbathSolver(HS), + phi4(_NumOp.GaugeGrid()) + {}; + + virtual std::string action_name(){return "TwoFlavourRatioEO4DPseudoFermionAction";} + + virtual std::string LogParameters(){ + std::stringstream sstream; + sstream << GridLogMessage << "["< sig^2 = 0.5. + // + // So eta should be of width sig = 1/sqrt(2) and must multiply by 0.707.... + // + RealD scale = std::sqrt(0.5); + + FermionField eta4(NumOp.GaugeGrid()); + FermionField eta5(NumOp.FermionGrid()); + FermionField tmp(NumOp.FermionGrid()); + FermionField phi5(NumOp.FermionGrid()); + + gaussian(pRNG,eta4); + NumOp.ImportFourDimPseudoFermion(eta4,eta5); + NumOp.ImportGauge(U); + DenOp.ImportGauge(U); + + SchurRedBlackDiagMooeeSolve PrecSolve(HeatbathSolver); + + DenOp.M(eta5,tmp); // M eta + PrecSolve(NumOp,tmp,phi5); // phi = V^-1 M eta + phi5=phi5*scale; + std::cout << GridLogMessage << "4d pf refresh "<< norm2(phi5)<<"\n"; + // Project to 4d + NumOp.ExportFourDimPseudoFermion(phi5,phi4); + + }; + + ////////////////////////////////////////////////////// + // S = phi^dag (V^dag M^-dag)_11 (M^-1 V)_11 phi + ////////////////////////////////////////////////////// + virtual RealD S(const GaugeField &U) { + + NumOp.ImportGauge(U); + DenOp.ImportGauge(U); + + FermionField Y4(NumOp.GaugeGrid()); + FermionField X(NumOp.FermionGrid()); + FermionField Y(NumOp.FermionGrid()); + FermionField phi5(NumOp.FermionGrid()); + + MdagMLinearOperator ,FermionField> MdagMOp(DenOp); + SchurRedBlackDiagMooeeSolve PrecSolve(ActionSolver); + + NumOp.ImportFourDimPseudoFermion(phi4,phi5); + NumOp.M(phi5,X); // X= V phi + PrecSolve(DenOp,X,Y); // Y= (MdagM)^-1 Mdag Vdag phi = M^-1 V phi + NumOp.ExportFourDimPseudoFermion(Y,Y4); + + RealD action = norm2(Y4); + + return action; + }; + + ////////////////////////////////////////////////////// + // dS/du = 2 Re phi^dag (V^dag M^-dag)_11 (M^-1 d V)_11 phi + // - 2 Re phi^dag (dV^dag M^-dag)_11 (M^-1 dM M^-1 V)_11 phi + ////////////////////////////////////////////////////// + virtual void deriv(const GaugeField &U,GaugeField & dSdU) { + + NumOp.ImportGauge(U); + DenOp.ImportGauge(U); + + FermionField X(NumOp.FermionGrid()); + FermionField Y(NumOp.FermionGrid()); + FermionField phi(NumOp.FermionGrid()); + FermionField Vphi(NumOp.FermionGrid()); + FermionField MinvVphi(NumOp.FermionGrid()); + FermionField tmp4(NumOp.GaugeGrid()); + FermionField MdagInvMinvVphi(NumOp.FermionGrid()); + + GaugeField force(NumOp.GaugeGrid()); + + //Y=V phi + //X = (Mdag V phi + //Y = (Mdag M)^-1 Mdag V phi = M^-1 V Phi + NumOp.ImportFourDimPseudoFermion(phi4,phi); + NumOp.M(phi,Vphi); // V phi + SchurRedBlackDiagMooeeSolve PrecSolve(DerivativeSolver); + PrecSolve(DenOp,Vphi,MinvVphi);// M^-1 V phi + std::cout << GridLogMessage << "4d deriv solve "<< norm2(MinvVphi)<<"\n"; + + // Projects onto the physical space and back + NumOp.ExportFourDimPseudoFermion(MinvVphi,tmp4); + NumOp.ImportFourDimPseudoFermion(tmp4,Y); + + SchurRedBlackDiagMooeeDagSolve PrecDagSolve(DerivativeDagSolver); + // X = proj M^-dag V phi + // Need an adjoint solve + PrecDagSolve(DenOp,Y,MdagInvMinvVphi); + std::cout << GridLogMessage << "4d deriv solve dag "<< norm2(MdagInvMinvVphi)<<"\n"; + + // phi^dag (Vdag Mdag^-1) (M^-1 dV) phi + NumOp.MDeriv(force ,MdagInvMinvVphi , phi, DaggerNo ); dSdU=force; + + // phi^dag (dVdag Mdag^-1) (M^-1 V) phi + NumOp.MDeriv(force , phi, MdagInvMinvVphi ,DaggerYes ); dSdU=dSdU+force; + + // - 2 Re phi^dag (dV^dag M^-dag)_11 (M^-1 dM M^-1 V)_11 phi + DenOp.MDeriv(force,MdagInvMinvVphi,MinvVphi,DaggerNo); dSdU=dSdU-force; + DenOp.MDeriv(force,MinvVphi,MdagInvMinvVphi,DaggerYes); dSdU=dSdU-force; + + dSdU *= -1.0; + //dSdU = - Ta(dSdU); + + }; +}; + +NAMESPACE_END(Grid); + + diff --git a/Grid/qcd/hmc/integrators/Integrator.h b/Grid/qcd/hmc/integrators/Integrator.h index 1985caf0..6ad0e078 100644 --- a/Grid/qcd/hmc/integrators/Integrator.h +++ b/Grid/qcd/hmc/integrators/Integrator.h @@ -143,6 +143,7 @@ protected: force = FieldImplementation::projectForce(force); // Ta for gauge fields double end_force = usecond(); + DumpSliceNorm("force ",force,Nd-1); MomFilter->applyFilter(force); std::cout << GridLogIntegrator << " update_P : Level [" << level <<"]["< hasenbusch({ light_mass, 0.04, 0.25, 0.4, 0.7 , pv_mass }); // FIXME: // Same in MC and MD // Need to mix precision too + OneFlavourRationalParams SFRp; + SFRp.lo = 4.0e-3; + SFRp.hi = 30.0; + SFRp.MaxIter = 10000; + SFRp.tolerance= 1.0e-8; + SFRp.mdtolerance= 1.0e-6; + SFRp.degree = 16; + SFRp.precision= 50; + SFRp.BoundsCheckFreq=5; + OneFlavourRationalParams OFRp; - OFRp.lo = 4.0e-3; + OFRp.lo = 1.0e-4; OFRp.hi = 30.0; OFRp.MaxIter = 10000; - OFRp.tolerance= 1.0e-10; + OFRp.tolerance= 1.0e-8; + OFRp.mdtolerance= 1.0e-6; OFRp.degree = 16; OFRp.precision= 50; - - std::vector hasenbusch({ 0.01, 0.04, 0.2 , pv_mass }); - std::vector dirichlet ({ true, true, true }); + OFRp.BoundsCheckFreq=5; auto GridPtr = TheHMC.Resources.GetCartesian(); auto GridRBPtr = TheHMC.Resources.GetRBCartesian(); @@ -133,7 +143,8 @@ int main(int argc, char **argv) { Block4[1] = Dirichlet[2]; Block4[2] = Dirichlet[3]; Block4[3] = Dirichlet[4]; - TheHMC.Resources.SetMomentumFilter(new DDHMCFilter(Block4)); + int Width=3; + TheHMC.Resources.SetMomentumFilter(new DDHMCFilter(Block4,Width)); ////////////////////////// // Fermion Grid @@ -150,7 +161,7 @@ int main(int argc, char **argv) { std::vector boundary = {1,1,1,-1}; FermionAction::ImplParams Params(boundary); - double StoppingCondition = 1e-10; + double StoppingCondition = 1e-8; double MaxCGIterations = 30000; ConjugateGradient CG(StoppingCondition,MaxCGIterations); @@ -158,8 +169,8 @@ int main(int argc, char **argv) { // Collect actions //////////////////////////////////// ActionLevel Level1(1); - ActionLevel Level2(2); - ActionLevel Level3(8); + ActionLevel Level2(4); + ActionLevel Level3(6); //////////////////////////////////// // Strange action @@ -167,8 +178,17 @@ int main(int argc, char **argv) { FermionAction StrangeOp (U,*FGrid,*FrbGrid,*GridPtr,*GridRBPtr,strange_mass,M5,b,c, Params); FermionAction StrangePauliVillarsOp(U,*FGrid,*FrbGrid,*GridPtr,*GridRBPtr,pv_mass, M5,b,c, Params); - OneFlavourEvenOddRatioRationalPseudoFermionAction StrangePseudoFermion(StrangePauliVillarsOp,StrangeOp,OFRp); - // Level1.push_back(&StrangePseudoFermion); + FermionAction StrangeOpDir (U,*FGrid,*FrbGrid,*GridPtr,*GridRBPtr,strange_mass,M5,b,c, Params); + FermionAction StrangePauliVillarsOpDir(U,*FGrid,*FrbGrid,*GridPtr,*GridRBPtr,pv_mass, M5,b,c, Params); + StrangeOpDir.DirichletBlock(Dirichlet); + StrangePauliVillarsOpDir.DirichletBlock(Dirichlet); + + OneFlavourEvenOddRatioRationalPseudoFermionAction StrangePseudoFermionBdy(StrangeOpDir,StrangeOp,SFRp); + OneFlavourEvenOddRatioRationalPseudoFermionAction StrangePseudoFermionLocal(StrangePauliVillarsOpDir,StrangeOpDir,SFRp); + OneFlavourEvenOddRatioRationalPseudoFermionAction StrangePseudoFermionPVBdy(StrangePauliVillarsOp,StrangePauliVillarsOpDir,SFRp); + Level1.push_back(&StrangePseudoFermionBdy); + Level2.push_back(&StrangePseudoFermionLocal); + Level1.push_back(&StrangePseudoFermionPVBdy); //////////////////////////////////// // up down action @@ -179,37 +199,49 @@ int main(int argc, char **argv) { std::vector dirichlet_num; int n_hasenbusch = hasenbusch.size(); - light_den.push_back(light_mass); - dirichlet_den.push_back(0); + light_den.push_back(light_mass); dirichlet_den.push_back(0); for(int h=0;h Numerators; std::vector Denominators; std::vector *> Quotients; + std::vector *> Bdys; for(int h=0;h(*Numerators[h],*Denominators[h],CG,CG)); + if(h!=0) { + Quotients.push_back (new TwoFlavourEvenOddRatioPseudoFermionAction(*Numerators[h],*Denominators[h],CG,CG)); + } else { + Bdys.push_back( new OneFlavourEvenOddRatioRationalPseudoFermionAction(*Numerators[h],*Denominators[h],OFRp)); + Bdys.push_back( new OneFlavourEvenOddRatioRationalPseudoFermionAction(*Numerators[h],*Denominators[h],OFRp)); + } if ( dirichlet_den[h]==1) Denominators[h]->DirichletBlock(Dirichlet); if ( dirichlet_num[h]==1) Numerators[h]->DirichletBlock(Dirichlet); } int nquo=Quotients.size(); - Level1.push_back(Quotients[0]); - Level1.push_back(Quotients[nquo-1]); - for(int h=1;h