From 3e80947c2bb61bf71002a84430d3384819d9cda3 Mon Sep 17 00:00:00 2001 From: Guido Cossu Date: Tue, 5 Jul 2016 12:03:54 +0100 Subject: [PATCH] Cleaned up HMC output. Tested smeared HMCs for single precision (OK) --- lib/Log.cc | 101 ++-- lib/Log.h | 7 +- lib/qcd/action/gauge/GaugeImpl.h | 331 +++++++------ lib/qcd/hmc/HMC.h | 348 +++++++------ lib/qcd/hmc/HmcRunner.h | 17 +- lib/qcd/utils/WilsonLoops.h | 821 ++++++++++++++++--------------- 6 files changed, 838 insertions(+), 787 deletions(-) diff --git a/lib/Log.cc b/lib/Log.cc index 438d2c97..02d2942d 100644 --- a/lib/Log.cc +++ b/lib/Log.cc @@ -1,51 +1,51 @@ - /************************************************************************************* +/************************************************************************************* - Grid physics library, www.github.com/paboyle/Grid +Grid physics library, www.github.com/paboyle/Grid - Source file: ./lib/Log.cc +Source file: ./lib/Log.cc - Copyright (C) 2015 +Copyright (C) 2015 Author: Antonin Portelli Author: Azusa Yamaguchi 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 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. +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. +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 */ +See the full license in the file "LICENSE" in the top level distribution +directory +*************************************************************************************/ +/* END LEGAL */ #include namespace Grid { - - GridStopWatch Logger::StopWatch; - std::ostream Logger::devnull(0); - - Colours GridLogColours (0); - GridLogger GridLogError (1,"Error",GridLogColours, "RED"); - GridLogger GridLogWarning (1,"Warning",GridLogColours, "YELLOW"); - GridLogger GridLogMessage (1,"Message",GridLogColours, "NORMAL"); - GridLogger GridLogDebug (1,"Debug",GridLogColours, "PURPLE"); - GridLogger GridLogPerformance(1,"Performance",GridLogColours, "GREEN"); - GridLogger GridLogIterative (1,"Iterative",GridLogColours, "BLUE"); - GridLogger GridLogIntegrator (1,"Integrator",GridLogColours, "BLUE"); -void GridLogConfigure(std::vector &logstreams) -{ +GridStopWatch Logger::StopWatch; +std::ostream Logger::devnull(0); + +Colours GridLogColours(0); +GridLogger GridLogError(1, "Error", GridLogColours, "RED"); +GridLogger GridLogWarning(1, "Warning", GridLogColours, "YELLOW"); +GridLogger GridLogMessage(1, "Message", GridLogColours, "NORMAL"); +GridLogger GridLogDebug(1, "Debug", GridLogColours, "PURPLE"); +GridLogger GridLogPerformance(1, "Performance", GridLogColours, "GREEN"); +GridLogger GridLogIterative(1, "Iterative", GridLogColours, "BLUE"); +GridLogger GridLogIntegrator(1, "Integrator", GridLogColours, "BLUE"); + +void GridLogConfigure(std::vector &logstreams) { GridLogError.Active(0); GridLogWarning.Active(0); GridLogMessage.Active(0); @@ -55,43 +55,38 @@ void GridLogConfigure(std::vector &logstreams) GridLogIntegrator.Active(0); GridLogColours.Active(0); - for(int i=0;i -Author: Azusa Yamaguchi -Author: Peter Boyle + Author: Antonin Portelli + Author: Azusa Yamaguchi + 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 @@ -49,7 +49,6 @@ protected: public: std::map colour; - Colours(bool activate=false){ Active(activate); }; diff --git a/lib/qcd/action/gauge/GaugeImpl.h b/lib/qcd/action/gauge/GaugeImpl.h index 19e2f6da..691d25f1 100644 --- a/lib/qcd/action/gauge/GaugeImpl.h +++ b/lib/qcd/action/gauge/GaugeImpl.h @@ -1,189 +1,188 @@ - /************************************************************************************* +/************************************************************************************* - Grid physics library, www.github.com/paboyle/Grid +Grid physics library, www.github.com/paboyle/Grid - Source file: ./lib/qcd/action/gauge/GaugeImpl.h +Source file: ./lib/qcd/action/gauge/GaugeImpl.h - Copyright (C) 2015 +Copyright (C) 2015 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 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. +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. +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 */ -#ifndef GRID_QCD_GAUGE_IMPL_H -#define GRID_QCD_GAUGE_IMPL_H +See the full license in the file "LICENSE" in the top level distribution +directory +*************************************************************************************/ +/* END LEGAL */ +#ifndef GRID_QCD_GAUGE_IMPL_H +#define GRID_QCD_GAUGE_IMPL_H namespace Grid { - namespace QCD { +namespace QCD { - - //////////////////////////////////////////////////////////////////////// - // Implementation dependent gauge types - //////////////////////////////////////////////////////////////////////// +//////////////////////////////////////////////////////////////////////// +// Implementation dependent gauge types +//////////////////////////////////////////////////////////////////////// -template class WilsonLoops; +template class WilsonLoops; -#define INHERIT_GIMPL_TYPES(GImpl) \ - typedef typename GImpl::Simd Simd;\ - typedef typename GImpl::GaugeLinkField GaugeLinkField;\ - typedef typename GImpl::GaugeField GaugeField;\ - typedef typename GImpl::SiteGaugeField SiteGaugeField;\ - typedef typename GImpl::SiteGaugeLink SiteGaugeLink; +#define INHERIT_GIMPL_TYPES(GImpl) \ + typedef typename GImpl::Simd Simd; \ + typedef typename GImpl::GaugeLinkField GaugeLinkField; \ + typedef typename GImpl::GaugeField GaugeField; \ + typedef typename GImpl::SiteGaugeField SiteGaugeField; \ + typedef typename GImpl::SiteGaugeLink SiteGaugeLink; - // - template - class GaugeImplTypes { - public: - - typedef S Simd; - - template using iImplGaugeLink = iScalar > >; - template using iImplGaugeField = iVector >, Nd >; - - typedef iImplGaugeLink SiteGaugeLink; - typedef iImplGaugeField SiteGaugeField; - - typedef Lattice GaugeLinkField; // bit ugly naming; polarised gauge field, lorentz... all ugly - typedef Lattice GaugeField; +// +template class GaugeImplTypes { +public: + typedef S Simd; - // Move this elsewhere? - static inline void AddGaugeLink(GaugeField& U, GaugeLinkField& W, int mu){ // U[mu] += W + template + using iImplGaugeLink = iScalar>>; + template + using iImplGaugeField = iVector>, Nd>; + + typedef iImplGaugeLink SiteGaugeLink; + typedef iImplGaugeField SiteGaugeField; + + typedef Lattice GaugeLinkField; // bit ugly naming; polarised + // gauge field, lorentz... all + // ugly + typedef Lattice GaugeField; + + // Move this elsewhere? + static inline void AddGaugeLink(GaugeField &U, GaugeLinkField &W, + int mu) { // U[mu] += W PARALLEL_FOR_LOOP - for(auto ss=0;ssoSites();ss++){ - U._odata[ss]._internal[mu] = U._odata[ss]._internal[mu] + W._odata[ss]._internal; - } + for (auto ss = 0; ss < U._grid->oSites(); ss++) { + U._odata[ss]._internal[mu] = + U._odata[ss]._internal[mu] + W._odata[ss]._internal; } - - - }; - - // Composition with smeared link, bc's etc.. probably need multiple inheritance - // Variable precision "S" and variable Nc - template - class PeriodicGaugeImpl : public GimplTypes { - public: - - INHERIT_GIMPL_TYPES(GimplTypes); - - //////////////////////////////////////////////////////////////////////////////////////////////////////////// - // Support needed for the assembly of loops including all boundary condition effects such as conjugate bcs - //////////////////////////////////////////////////////////////////////////////////////////////////////////// - - template static inline - Lattice CovShiftForward (const GaugeLinkField &Link, int mu, const Lattice &field) { - return PeriodicBC::CovShiftForward(Link,mu,field); - } - - template static inline - Lattice CovShiftBackward(const GaugeLinkField &Link, int mu,const Lattice &field) { - return PeriodicBC::CovShiftBackward(Link,mu,field); - } - static inline - GaugeLinkField CovShiftIdentityBackward(const GaugeLinkField &Link, int mu) { - return Cshift(adj(Link),mu,-1); - } - static inline - GaugeLinkField CovShiftIdentityForward(const GaugeLinkField &Link, int mu) { - return Link; - } - static inline - GaugeLinkField ShiftStaple(const GaugeLinkField &Link, int mu) { - return Cshift(Link,mu,1); - } - - static inline bool isPeriodicGaugeField(void) { - return true; - } - - }; - - - // Composition with smeared link, bc's etc.. probably need multiple inheritance - // Variable precision "S" and variable Nc - template - class ConjugateGaugeImpl : public GimplTypes { - public: - - INHERIT_GIMPL_TYPES(GimplTypes); - - //////////////////////////////////////////////////////////////////////////////////////////////////////////// - // Support needed for the assembly of loops including all boundary condition effects such as Gparity. - //////////////////////////////////////////////////////////////////////////////////////////////////////////// - template static - Lattice CovShiftForward (const GaugeLinkField &Link, int mu, const Lattice &field) { - return ConjugateBC::CovShiftForward(Link,mu,field); - } - - template static - Lattice CovShiftBackward(const GaugeLinkField &Link, int mu,const Lattice &field) { - return ConjugateBC::CovShiftBackward(Link,mu,field); - } - - static inline - GaugeLinkField CovShiftIdentityBackward(const GaugeLinkField &Link, int mu) { - GridBase *grid = Link._grid; - int Lmu = grid->GlobalDimensions()[mu]-1; - - Lattice > coor(grid); LatticeCoordinate(coor,mu); - - GaugeLinkField tmp (grid); - tmp=adj(Link); - tmp = where(coor==Lmu,conjugate(tmp),tmp); - return Cshift(tmp,mu,-1);// moves towards positive mu - } - static inline - GaugeLinkField CovShiftIdentityForward(const GaugeLinkField &Link, int mu) { - return Link; - } - - static inline - GaugeLinkField ShiftStaple(const GaugeLinkField &Link, int mu) { - GridBase *grid = Link._grid; - int Lmu = grid->GlobalDimensions()[mu]-1; - - Lattice > coor(grid); LatticeCoordinate(coor,mu); - - GaugeLinkField tmp (grid); - tmp=Cshift(Link,mu,1); - tmp=where(coor==Lmu,conjugate(tmp),tmp); - return tmp; - } - - static inline bool isPeriodicGaugeField(void) { - return false; - } - - }; - - typedef GaugeImplTypes GimplTypesR; - typedef GaugeImplTypes GimplTypesF; - typedef GaugeImplTypes GimplTypesD; - - typedef PeriodicGaugeImpl PeriodicGimplR; // Real.. whichever prec - typedef PeriodicGaugeImpl PeriodicGimplF; // Float - typedef PeriodicGaugeImpl PeriodicGimplD; // Double - - typedef ConjugateGaugeImpl ConjugateGimplR; // Real.. whichever prec - typedef ConjugateGaugeImpl ConjugateGimplF; // Float - typedef ConjugateGaugeImpl ConjugateGimplD; // Double - } +}; + +// Composition with smeared link, bc's etc.. probably need multiple inheritance +// Variable precision "S" and variable Nc +template class PeriodicGaugeImpl : public GimplTypes { +public: + INHERIT_GIMPL_TYPES(GimplTypes); + + //////////////////////////////////////////////////////////////////////////////////////////////////////////// + // Support needed for the assembly of loops including all boundary condition + // effects such as conjugate bcs + //////////////////////////////////////////////////////////////////////////////////////////////////////////// + + template + static inline Lattice + CovShiftForward(const GaugeLinkField &Link, int mu, + const Lattice &field) { + return PeriodicBC::CovShiftForward(Link, mu, field); + } + + template + static inline Lattice + CovShiftBackward(const GaugeLinkField &Link, int mu, + const Lattice &field) { + return PeriodicBC::CovShiftBackward(Link, mu, field); + } + static inline GaugeLinkField + CovShiftIdentityBackward(const GaugeLinkField &Link, int mu) { + return Cshift(adj(Link), mu, -1); + } + static inline GaugeLinkField + CovShiftIdentityForward(const GaugeLinkField &Link, int mu) { + return Link; + } + static inline GaugeLinkField ShiftStaple(const GaugeLinkField &Link, int mu) { + return Cshift(Link, mu, 1); + } + + static inline bool isPeriodicGaugeField(void) { return true; } +}; + +// Composition with smeared link, bc's etc.. probably need multiple inheritance +// Variable precision "S" and variable Nc +template class ConjugateGaugeImpl : public GimplTypes { +public: + INHERIT_GIMPL_TYPES(GimplTypes); + + //////////////////////////////////////////////////////////////////////////////////////////////////////////// + // Support needed for the assembly of loops including all boundary condition + // effects such as Gparity. + //////////////////////////////////////////////////////////////////////////////////////////////////////////// + template + static Lattice CovShiftForward(const GaugeLinkField &Link, int mu, + const Lattice &field) { + return ConjugateBC::CovShiftForward(Link, mu, field); + } + + template + static Lattice CovShiftBackward(const GaugeLinkField &Link, int mu, + const Lattice &field) { + return ConjugateBC::CovShiftBackward(Link, mu, field); + } + + static inline GaugeLinkField + CovShiftIdentityBackward(const GaugeLinkField &Link, int mu) { + GridBase *grid = Link._grid; + int Lmu = grid->GlobalDimensions()[mu] - 1; + + Lattice> coor(grid); + LatticeCoordinate(coor, mu); + + GaugeLinkField tmp(grid); + tmp = adj(Link); + tmp = where(coor == Lmu, conjugate(tmp), tmp); + return Cshift(tmp, mu, -1); // moves towards positive mu + } + static inline GaugeLinkField + CovShiftIdentityForward(const GaugeLinkField &Link, int mu) { + return Link; + } + + static inline GaugeLinkField ShiftStaple(const GaugeLinkField &Link, int mu) { + GridBase *grid = Link._grid; + int Lmu = grid->GlobalDimensions()[mu] - 1; + + Lattice> coor(grid); + LatticeCoordinate(coor, mu); + + GaugeLinkField tmp(grid); + tmp = Cshift(Link, mu, 1); + tmp = where(coor == Lmu, conjugate(tmp), tmp); + return tmp; + } + + static inline bool isPeriodicGaugeField(void) { return false; } +}; + +typedef GaugeImplTypes GimplTypesR; +typedef GaugeImplTypes GimplTypesF; +typedef GaugeImplTypes GimplTypesD; + +typedef PeriodicGaugeImpl PeriodicGimplR; // Real.. whichever prec +typedef PeriodicGaugeImpl PeriodicGimplF; // Float +typedef PeriodicGaugeImpl PeriodicGimplD; // Double + +typedef ConjugateGaugeImpl + ConjugateGimplR; // Real.. whichever prec +typedef ConjugateGaugeImpl ConjugateGimplF; // Float +typedef ConjugateGaugeImpl ConjugateGimplD; // Double +} } #endif diff --git a/lib/qcd/hmc/HMC.h b/lib/qcd/hmc/HMC.h index b471eb3a..05838349 100644 --- a/lib/qcd/hmc/HMC.h +++ b/lib/qcd/hmc/HMC.h @@ -1,33 +1,34 @@ - /************************************************************************************* +/************************************************************************************* - Grid physics library, www.github.com/paboyle/Grid +Grid physics library, www.github.com/paboyle/Grid - Source file: ./lib/qcd/hmc/HMC.h +Source file: ./lib/qcd/hmc/HMC.h - Copyright (C) 2015 +Copyright (C) 2015 Author: Azusa Yamaguchi Author: Peter Boyle Author: neo 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 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. +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. +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 */ +See the full license in the file "LICENSE" in the top level distribution +directory +*************************************************************************************/ +/* END LEGAL */ //-------------------------------------------------------------------- /*! @file HMC.h * @brief Classes for Hybrid Monte Carlo update @@ -41,172 +42,195 @@ Author: paboyle #include +namespace Grid { +namespace QCD { -namespace Grid{ - namespace QCD{ - +struct HMCparameters { + Integer StartTrajectory; + Integer Trajectories; /* @brief Number of sweeps in this run */ + bool MetropolisTest; + Integer NoMetropolisUntil; - struct HMCparameters{ + HMCparameters() { + ////////////////////////////// Default values + MetropolisTest = true; + NoMetropolisUntil = 10; + StartTrajectory = 0; + Trajectories = 200; + ///////////////////////////////// + } - Integer StartTrajectory; - Integer Trajectories; /* @brief Number of sweeps in this run */ - bool MetropolisTest; - Integer NoMetropolisUntil; + void print() const { + std::cout << GridLogMessage << "[HMC parameter] Trajectories : " << Trajectories << "\n"; + std::cout << GridLogMessage << "[HMC parameter] Start trajectory : " << StartTrajectory << "\n"; + std::cout << GridLogMessage << "[HMC parameter] Metropolis test (on/off): " << MetropolisTest << "\n"; + std::cout << GridLogMessage << "[HMC parameter] Thermalization trajs : " << NoMetropolisUntil << "\n"; + } + +}; - HMCparameters(){ - ////////////////////////////// Default values - MetropolisTest = true; - NoMetropolisUntil = 10; - StartTrajectory = 0; - Trajectories = 200; - ///////////////////////////////// - } - }; +template +class HmcObservable { + public: + virtual void TrajectoryComplete(int traj, GaugeField &U, GridSerialRNG &sRNG, + GridParallelRNG &pRNG) = 0; +}; - template - class HmcObservable { - public: - virtual void TrajectoryComplete (int traj, GaugeField &U, GridSerialRNG &sRNG, GridParallelRNG & pRNG )=0; - }; +template +class PlaquetteLogger : public HmcObservable { + private: + std::string Stem; - template - class PlaquetteLogger : public HmcObservable { - private: - std::string Stem; - public: - INHERIT_GIMPL_TYPES(Gimpl); - PlaquetteLogger(std::string cf) { - Stem = cf; - }; + public: + INHERIT_GIMPL_TYPES(Gimpl); + PlaquetteLogger(std::string cf) { Stem = cf; }; - void TrajectoryComplete(int traj, GaugeField &U, GridSerialRNG &sRNG, GridParallelRNG & pRNG ) - { - std::string file; { std::ostringstream os; os << Stem <<"."<< traj; file = os.str(); } - std::ofstream of(file); + void TrajectoryComplete(int traj, GaugeField &U, GridSerialRNG &sRNG, + GridParallelRNG &pRNG) { + std::string file; + { + std::ostringstream os; + os << Stem << "." << traj; + file = os.str(); + } + std::ofstream of(file); - RealD peri_plaq = WilsonLoops::avgPlaquette(U); - RealD peri_rect = WilsonLoops::avgRectangle(U); + RealD peri_plaq = WilsonLoops::avgPlaquette(U); + RealD peri_rect = WilsonLoops::avgRectangle(U); - RealD impl_plaq = WilsonLoops::avgPlaquette(U); - RealD impl_rect = WilsonLoops::avgRectangle(U); + RealD impl_plaq = WilsonLoops::avgPlaquette(U); + RealD impl_rect = WilsonLoops::avgRectangle(U); - of << traj<<" "<< impl_plaq << " " << impl_rect << " "<< peri_plaq<<" "< - template - class HybridMonteCarlo { - private: +// template +template +class HybridMonteCarlo { + private: + const HMCparameters Params; - const HMCparameters Params; - - GridSerialRNG &sRNG; // Fixme: need a RNG management strategy. - GridParallelRNG &pRNG; // Fixme: need a RNG management strategy. - GaugeField & Ucur; + GridSerialRNG &sRNG; // Fixme: need a RNG management strategy. + GridParallelRNG &pRNG; // Fixme: need a RNG management strategy. + GaugeField &Ucur; - IntegratorType &TheIntegrator; - std::vector *> Observables; + IntegratorType &TheIntegrator; + std::vector *> Observables; - ///////////////////////////////////////////////////////// - // Metropolis step - ///////////////////////////////////////////////////////// - bool metropolis_test(const RealD DeltaH){ + ///////////////////////////////////////////////////////// + // Metropolis step + ///////////////////////////////////////////////////////// + bool metropolis_test(const RealD DeltaH) { + RealD rn_test; - RealD rn_test; + RealD prob = std::exp(-DeltaH); - RealD prob = std::exp(-DeltaH); + random(sRNG, rn_test); - random(sRNG,rn_test); - - std::cout<1.0) || (rn_test <= prob)){ // accepted - std::cout< 1.0) || (rn_test <= prob)) { // accepted + std::cout << GridLogMessage << "Metropolis_test -- ACCEPTED\n"; + std::cout << GridLogMessage + << "--------------------------------------------------\n"; + return true; + } else { // rejected + std::cout << GridLogMessage << "Metropolis_test -- REJECTED\n"; + std::cout << GridLogMessage + << "--------------------------------------------------\n"; + return false; + } + } + + ///////////////////////////////////////////////////////// + // Evolution + ///////////////////////////////////////////////////////// + RealD evolve_step(GaugeField &U) { + TheIntegrator.refresh(U, pRNG); // set U and initialize P and phi's + + RealD H0 = TheIntegrator.S(U); // initial state action + + std::streamsize current_precision = std::cout.precision(); + std::cout.precision(17); + std::cout << GridLogMessage << "Total H before trajectory = " << H0 << "\n"; + std::cout.precision(current_precision); + + TheIntegrator.integrate(U); + + RealD H1 = TheIntegrator.S(U); // updated state action + + std::cout.precision(17); + std::cout << GridLogMessage << "Total H after trajectory = " << H1 + << " dH = " << H1 - H0 << "\n"; + std::cout.precision(current_precision); + + return (H1 - H0); + } + + public: + ///////////////////////////////////////// + // Constructor + ///////////////////////////////////////// + HybridMonteCarlo(HMCparameters Pams, IntegratorType &_Int, + GridSerialRNG &_sRNG, GridParallelRNG &_pRNG, GaugeField &_U) + : Params(Pams), TheIntegrator(_Int), sRNG(_sRNG), pRNG(_pRNG), Ucur(_U) {} + ~HybridMonteCarlo(){}; + + void AddObservable(HmcObservable *obs) { + Observables.push_back(obs); + } + + void evolve(void) { + Real DeltaH; + + GaugeField Ucopy(Ucur._grid); + + Params.print(); + + // Actual updates (evolve a copy Ucopy then copy back eventually) + for (int traj = Params.StartTrajectory; + traj < Params.Trajectories + Params.StartTrajectory; ++traj) { + std::cout << GridLogMessage << "-- # Trajectory = " << traj << "\n"; + Ucopy = Ucur; + + DeltaH = evolve_step(Ucopy); + + bool accept = true; + if (traj >= Params.NoMetropolisUntil) { + accept = metropolis_test(DeltaH); } - ///////////////////////////////////////////////////////// - // Evolution - ///////////////////////////////////////////////////////// - RealD evolve_step(GaugeField& U){ - - TheIntegrator.refresh(U,pRNG); // set U and initialize P and phi's - - RealD H0 = TheIntegrator.S(U); // initial state action - - std::cout< *obs) { - Observables.push_back(obs); + if (accept) { + Ucur = Ucopy; } - void evolve(void){ - - Real DeltaH; - - GaugeField Ucopy(Ucur._grid); - - // Actual updates (evolve a copy Ucopy then copy back eventually) - for(int traj=Params.StartTrajectory; traj < Params.Trajectories+Params.StartTrajectory; ++traj){ - - std::cout< Params.NoMetropolisUntil) { - accept = metropolis_test(DeltaH); - } - - if ( accept ) { - Ucur = Ucopy; - } - - for(int obs = 0;obsTrajectoryComplete (traj+1,Ucur,sRNG,pRNG); - } - - } + for (int obs = 0; obs < Observables.size(); obs++) { + Observables[obs]->TrajectoryComplete(traj + 1, Ucur, sRNG, pRNG); } - }; - - }// QCD -}// Grid + } + } +}; +} // QCD +} // Grid -#endif +#endif diff --git a/lib/qcd/hmc/HmcRunner.h b/lib/qcd/hmc/HmcRunner.h index 17e3b443..5616582f 100644 --- a/lib/qcd/hmc/HmcRunner.h +++ b/lib/qcd/hmc/HmcRunner.h @@ -81,6 +81,14 @@ public: NumTraj = ivec[0]; } + int NumThermalizations = 10; + if( GridCmdOptionExists(argv,argv+argc,"--Thermalizations") ){ + arg= GridCmdOptionPayload(argv,argv+argc,"--Thermalizations"); + std::vector ivec(0); + GridCmdOptionIntVector(arg,ivec); + NumThermalizations = ivec[0]; + } + GridSerialRNG sRNG; GridParallelRNG pRNG(UGrid); @@ -110,33 +118,30 @@ public: PlaquetteLogger PlaqLog(std::string("plaq")); HMCparameters HMCpar; - HMCpar.StartTrajectory = StartTraj; - HMCpar.Trajectories = NumTraj; + HMCpar.StartTrajectory = StartTraj; + HMCpar.Trajectories = NumTraj; + HMCpar.NoMetropolisUntil = NumThermalizations; if ( StartType == HotStart ) { // Hot start - HMCpar.NoMetropolisUntil =10; HMCpar.MetropolisTest = true; sRNG.SeedFixedIntegers(SerSeed); pRNG.SeedFixedIntegers(ParSeed); SU3::HotConfiguration(pRNG, U); } else if ( StartType == ColdStart ) { // Cold start - HMCpar.NoMetropolisUntil =10; HMCpar.MetropolisTest = true; sRNG.SeedFixedIntegers(SerSeed); pRNG.SeedFixedIntegers(ParSeed); SU3::ColdConfiguration(pRNG, U); } else if ( StartType == TepidStart ) { // Tepid start - HMCpar.NoMetropolisUntil =10; HMCpar.MetropolisTest = true; sRNG.SeedFixedIntegers(SerSeed); pRNG.SeedFixedIntegers(ParSeed); SU3::TepidConfiguration(pRNG, U); } else if ( StartType == CheckpointStart ) { - HMCpar.NoMetropolisUntil =10; HMCpar.MetropolisTest = true; // CheckpointRestart Checkpoint.CheckpointRestore(StartTraj, U, sRNG, pRNG); diff --git a/lib/qcd/utils/WilsonLoops.h b/lib/qcd/utils/WilsonLoops.h index 55fd5b7e..10022f50 100644 --- a/lib/qcd/utils/WilsonLoops.h +++ b/lib/qcd/utils/WilsonLoops.h @@ -1,6 +1,6 @@ /************************************************************************************* - Grid physics library, www.github.com/paboyle/Grid + Grid physics library, www.github.com/paboyle/Grid Source file: ./lib/qcd/utils/WilsonLoops.h @@ -25,472 +25,501 @@ Author: paboyle 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 + See the full license in the file "LICENSE" in the top level distribution +directory *************************************************************************************/ /* END LEGAL */ #ifndef QCD_UTILS_WILSON_LOOPS_H #define QCD_UTILS_WILSON_LOOPS_H namespace Grid { - namespace QCD { - - // Common wilson loop observables - template - class WilsonLoops : public Gimpl { - public: - - INHERIT_GIMPL_TYPES(Gimpl); - - typedef typename Gimpl::GaugeLinkField GaugeMat; - typedef typename Gimpl::GaugeField GaugeLorentz; - - ////////////////////////////////////////////////// - // directed plaquette oriented in mu,nu plane - ////////////////////////////////////////////////// - static void dirPlaquette(GaugeMat &plaq,const std::vector &U, const int mu, const int nu) - { - // Annoyingly, must use either scope resolution to find dependent base class, - // or this-> ; there is no "this" in a static method. This forces explicit Gimpl scope - // resolution throughout the usage in this file, and rather defeats the purpose of deriving - // from Gimpl. - plaq = Gimpl::CovShiftBackward(U[mu],mu, - Gimpl::CovShiftBackward(U[nu],nu, - Gimpl::CovShiftForward (U[mu],mu,U[nu]))); - } - ////////////////////////////////////////////////// - // trace of directed plaquette oriented in mu,nu plane - ////////////////////////////////////////////////// - static void traceDirPlaquette(LatticeComplex &plaq, const std::vector &U, const int mu, const int nu) - { - GaugeMat sp(U[0]._grid); - dirPlaquette(sp,U,mu,nu); - plaq=trace(sp); - } - ////////////////////////////////////////////////// - // sum over all planes of plaquette - ////////////////////////////////////////////////// - static void sitePlaquette(LatticeComplex &Plaq,const std::vector &U) - { - LatticeComplex sitePlaq(U[0]._grid); - Plaq=zero; - for(int mu=1;mu U(4,Umu._grid); - - for(int mu=0;mu(Umu,mu); - } - - LatticeComplex Plaq(Umu._grid); - - sitePlaquette(Plaq,U); - - TComplex Tp = sum(Plaq); - Complex p = TensorRemove(Tp); - return p.real(); - } - ////////////////////////////////////////////////// - // average over all x,y,z,t and over all planes of plaquette - ////////////////////////////////////////////////// - static RealD avgPlaquette(const GaugeLorentz &Umu){ - RealD sumplaq = sumPlaquette(Umu); - double vol = Umu._grid->gSites(); - double faces = (1.0*Nd*(Nd-1))/2.0; - return sumplaq/vol/faces/Nc; // Nd , Nc dependent... FIXME - } +namespace QCD { - ////////////////////////////////////////////////// - // average over traced single links - ////////////////////////////////////////////////// - static RealD linkTrace(const GaugeLorentz &Umu){ - std::vector U(4,Umu._grid); - - LatticeComplex Tr(Umu._grid); Tr=zero; - for(int mu=0;mu(Umu,mu); - Tr = Tr+trace(U[mu]); - } - - TComplex Tp = sum(Tr); - Complex p = TensorRemove(Tp); - - double vol = Umu._grid->gSites(); - - return p.real()/vol/4.0/3.0; - }; - - ////////////////////////////////////////////////// - // the sum over all staples on each site in direction mu,nu - ////////////////////////////////////////////////// - static void Staple(GaugeMat &staple,const GaugeLorentz &Umu,int mu, int nu){ +// Common wilson loop observables +template class WilsonLoops : public Gimpl { +public: + INHERIT_GIMPL_TYPES(Gimpl); - GridBase *grid = Umu._grid; - - std::vector U(4,grid); - for(int d=0;d(Umu,d); - } - staple = zero; - - - if(nu != mu) { - - // mu - // ^ - // |__> nu - - // __ - // | - // __| - // + typedef typename Gimpl::GaugeLinkField GaugeMat; + typedef typename Gimpl::GaugeField GaugeLorentz; - staple+=Gimpl::ShiftStaple( - Gimpl::CovShiftForward (U[nu],nu, - Gimpl::CovShiftBackward(U[mu],mu, - Gimpl::CovShiftIdentityBackward(U[nu],nu))),mu); - - // __ - // | - // |__ - // - // - staple+=Gimpl::ShiftStaple( - Gimpl::CovShiftBackward(U[nu],nu, - Gimpl::CovShiftBackward(U[mu],mu,U[nu])),mu); - - } - } - -////////////////////////////////////////////////// -// the sum over all staples on each site -////////////////////////////////////////////////// - static void Staple(GaugeMat &staple,const GaugeLorentz &Umu,int mu){ - - GridBase *grid = Umu._grid; - - std::vector U(Nd,grid); - for(int d=0;d(Umu,d); - } - staple = zero; - GaugeMat tmp(grid); - - - for(int nu=0;nu nu - - // __ - // | - // __| - // - - staple+=Gimpl::ShiftStaple( - Gimpl::CovShiftForward (U[nu],nu, - Gimpl::CovShiftBackward(U[mu],mu, - Gimpl::CovShiftIdentityBackward(U[nu],nu))),mu); - - // __ - // | - // |__ - // - // - staple+=Gimpl::ShiftStaple( - Gimpl::CovShiftBackward(U[nu],nu, - Gimpl::CovShiftBackward(U[mu],mu,U[nu])),mu); - } - } + ////////////////////////////////////////////////// + // directed plaquette oriented in mu,nu plane + ////////////////////////////////////////////////// + static void dirPlaquette(GaugeMat &plaq, const std::vector &U, + const int mu, const int nu) { + // Annoyingly, must use either scope resolution to find dependent base + // class, + // or this-> ; there is no "this" in a static method. This forces explicit + // Gimpl scope + // resolution throughout the usage in this file, and rather defeats the + // purpose of deriving + // from Gimpl. + plaq = Gimpl::CovShiftBackward( + U[mu], mu, Gimpl::CovShiftBackward( + U[nu], nu, Gimpl::CovShiftForward(U[mu], mu, U[nu]))); } - - - ////////////////////////////////////////////////// - // the sum over all staples on each site in direction mu,nu, upper part - ////////////////////////////////////////////////// - static void StapleUpper(GaugeMat &staple,const GaugeLorentz &Umu,int mu, int nu){ - - staple = zero; - - if(nu != mu) { - GridBase *grid = Umu._grid; - - std::vector U(4,grid); - for(int d=0;d(Umu,d); - } - - // mu - // ^ - // |__> nu - - // __ - // | - // __| - // - - staple+=Gimpl::ShiftStaple( - Gimpl::CovShiftForward (U[nu],nu, - Gimpl::CovShiftBackward(U[mu],mu, - Gimpl::CovShiftIdentityBackward(U[nu],nu))),mu); - - } - } - - - - - - ////////////////////////////////////////////////////// - // Similar to above for rectangle is required - ////////////////////////////////////////////////////// - static void dirRectangle(GaugeMat &rect,const std::vector &U, const int mu, const int nu) - { - rect = Gimpl::CovShiftForward(U[mu],mu,Gimpl::CovShiftForward(U[mu],mu,U[nu]))* // ->->| - adj(Gimpl::CovShiftForward(U[nu],nu,Gimpl::CovShiftForward(U[mu],mu,U[mu]))) ; - rect = rect + - Gimpl::CovShiftForward(U[mu],mu,Gimpl::CovShiftForward(U[nu],nu,U[nu]))* // ->|| - adj(Gimpl::CovShiftForward(U[nu],nu,Gimpl::CovShiftForward(U[nu],nu,U[mu]))) ; - } - static void traceDirRectangle(LatticeComplex &rect, const std::vector &U, const int mu, const int nu) - { + ////////////////////////////////////////////////// + // trace of directed plaquette oriented in mu,nu plane + ////////////////////////////////////////////////// + static void traceDirPlaquette(LatticeComplex &plaq, + const std::vector &U, const int mu, + const int nu) { GaugeMat sp(U[0]._grid); - dirRectangle(sp,U,mu,nu); - rect=trace(sp); + dirPlaquette(sp, U, mu, nu); + plaq = trace(sp); } - static void siteRectangle(LatticeComplex &Rect,const std::vector &U) - { - LatticeComplex siteRect(U[0]._grid); - Rect=zero; - for(int mu=1;mu &U) { + LatticeComplex sitePlaq(U[0]._grid); + Plaq = zero; + for (int mu = 1; mu < Nd; mu++) { + for (int nu = 0; nu < mu; nu++) { + traceDirPlaquette(sitePlaq, U, mu, nu); + Plaq = Plaq + sitePlaq; } } } - - ////////////////////////////////////////////////// + ////////////////////////////////////////////////// // sum over all x,y,z,t and over all planes of plaquette ////////////////////////////////////////////////// - static RealD sumRectangle(const GaugeLorentz &Umu){ - std::vector U(Nd,Umu._grid); + static RealD sumPlaquette(const GaugeLorentz &Umu) { + std::vector U(4, Umu._grid); - for(int mu=0;mu(Umu,mu); + for (int mu = 0; mu < Nd; mu++) { + U[mu] = PeekIndex(Umu, mu); } - LatticeComplex Rect(Umu._grid); - - siteRectangle(Rect,U); - - TComplex Tp = sum(Rect); - Complex p = TensorRemove(Tp); + LatticeComplex Plaq(Umu._grid); + + sitePlaquette(Plaq, U); + + TComplex Tp = sum(Plaq); + Complex p = TensorRemove(Tp); return p.real(); } ////////////////////////////////////////////////// // average over all x,y,z,t and over all planes of plaquette ////////////////////////////////////////////////// - static RealD avgRectangle(const GaugeLorentz &Umu){ - - RealD sumrect = sumRectangle(Umu); - + static RealD avgPlaquette(const GaugeLorentz &Umu) { + RealD sumplaq = sumPlaquette(Umu); double vol = Umu._grid->gSites(); - - double faces = (1.0*Nd*(Nd-1)); // 2 distinct orientations summed - - return sumrect/vol/faces/Nc; // Nd , Nc dependent... FIXME + double faces = (1.0 * Nd * (Nd - 1)) / 2.0; + return sumplaq / vol / faces / Nc; // Nd , Nc dependent... FIXME + } + + ////////////////////////////////////////////////// + // average over traced single links + ////////////////////////////////////////////////// + static RealD linkTrace(const GaugeLorentz &Umu) { + std::vector U(4, Umu._grid); + + LatticeComplex Tr(Umu._grid); + Tr = zero; + for (int mu = 0; mu < Nd; mu++) { + U[mu] = PeekIndex(Umu, mu); + Tr = Tr + trace(U[mu]); + } + + TComplex Tp = sum(Tr); + Complex p = TensorRemove(Tp); + + double vol = Umu._grid->gSites(); + + return p.real() / vol / 4.0 / 3.0; + }; + + ////////////////////////////////////////////////// + // the sum over all staples on each site in direction mu,nu + ////////////////////////////////////////////////// + static void Staple(GaugeMat &staple, const GaugeLorentz &Umu, int mu, + int nu) { + + GridBase *grid = Umu._grid; + + std::vector U(4, grid); + for (int d = 0; d < Nd; d++) { + U[d] = PeekIndex(Umu, d); + } + staple = zero; + + if (nu != mu) { + + // mu + // ^ + // |__> nu + + // __ + // | + // __| + // + + staple += Gimpl::ShiftStaple( + Gimpl::CovShiftForward( + U[nu], nu, + Gimpl::CovShiftBackward( + U[mu], mu, Gimpl::CovShiftIdentityBackward(U[nu], nu))), + mu); + + // __ + // | + // |__ + // + // + staple += Gimpl::ShiftStaple( + Gimpl::CovShiftBackward(U[nu], nu, + Gimpl::CovShiftBackward(U[mu], mu, U[nu])), + mu); + } } ////////////////////////////////////////////////// // the sum over all staples on each site ////////////////////////////////////////////////// - static void RectStapleDouble(GaugeMat &U2,const GaugeMat & U,int mu){ - U2 = U * Cshift(U,mu,1); + static void Staple(GaugeMat &staple, const GaugeLorentz &Umu, int mu) { + + GridBase *grid = Umu._grid; + + std::vector U(Nd, grid); + for (int d = 0; d < Nd; d++) { + U[d] = PeekIndex(Umu, d); + } + staple = zero; + GaugeMat tmp(grid); + + for (int nu = 0; nu < Nd; nu++) { + + if (nu != mu) { + + // mu + // ^ + // |__> nu + + // __ + // | + // __| + // + + staple += Gimpl::ShiftStaple( + Gimpl::CovShiftForward( + U[nu], nu, + Gimpl::CovShiftBackward( + U[mu], mu, Gimpl::CovShiftIdentityBackward(U[nu], nu))), + mu); + + // __ + // | + // |__ + // + // + staple += Gimpl::ShiftStaple( + Gimpl::CovShiftBackward(U[nu], nu, + Gimpl::CovShiftBackward(U[mu], mu, U[nu])), + mu); + } + } + } + + ////////////////////////////////////////////////// + // the sum over all staples on each site in direction mu,nu, upper part + ////////////////////////////////////////////////// + static void StapleUpper(GaugeMat &staple, const GaugeLorentz &Umu, int mu, + int nu) { + + staple = zero; + + if (nu != mu) { + GridBase *grid = Umu._grid; + + std::vector U(4, grid); + for (int d = 0; d < Nd; d++) { + U[d] = PeekIndex(Umu, d); + } + + // mu + // ^ + // |__> nu + + // __ + // | + // __| + // + + staple += Gimpl::ShiftStaple( + Gimpl::CovShiftForward( + U[nu], nu, + Gimpl::CovShiftBackward( + U[mu], mu, Gimpl::CovShiftIdentityBackward(U[nu], nu))), + mu); + } + } + + ////////////////////////////////////////////////////// + // Similar to above for rectangle is required + ////////////////////////////////////////////////////// + static void dirRectangle(GaugeMat &rect, const std::vector &U, + const int mu, const int nu) { + rect = Gimpl::CovShiftForward( + U[mu], mu, Gimpl::CovShiftForward(U[mu], mu, U[nu])) * // ->->| + adj(Gimpl::CovShiftForward( + U[nu], nu, Gimpl::CovShiftForward(U[mu], mu, U[mu]))); + rect = rect + + Gimpl::CovShiftForward( + U[mu], mu, Gimpl::CovShiftForward(U[nu], nu, U[nu])) * // ->|| + adj(Gimpl::CovShiftForward( + U[nu], nu, Gimpl::CovShiftForward(U[nu], nu, U[mu]))); + } + static void traceDirRectangle(LatticeComplex &rect, + const std::vector &U, const int mu, + const int nu) { + GaugeMat sp(U[0]._grid); + dirRectangle(sp, U, mu, nu); + rect = trace(sp); + } + static void siteRectangle(LatticeComplex &Rect, + const std::vector &U) { + LatticeComplex siteRect(U[0]._grid); + Rect = zero; + for (int mu = 1; mu < Nd; mu++) { + for (int nu = 0; nu < mu; nu++) { + traceDirRectangle(siteRect, U, mu, nu); + Rect = Rect + siteRect; + } + } + } + + ////////////////////////////////////////////////// + // sum over all x,y,z,t and over all planes of plaquette + ////////////////////////////////////////////////// + static RealD sumRectangle(const GaugeLorentz &Umu) { + std::vector U(Nd, Umu._grid); + + for (int mu = 0; mu < Nd; mu++) { + U[mu] = PeekIndex(Umu, mu); + } + + LatticeComplex Rect(Umu._grid); + + siteRectangle(Rect, U); + + TComplex Tp = sum(Rect); + Complex p = TensorRemove(Tp); + return p.real(); + } + ////////////////////////////////////////////////// + // average over all x,y,z,t and over all planes of plaquette + ////////////////////////////////////////////////// + static RealD avgRectangle(const GaugeLorentz &Umu) { + + RealD sumrect = sumRectangle(Umu); + + double vol = Umu._grid->gSites(); + + double faces = (1.0 * Nd * (Nd - 1)); // 2 distinct orientations summed + + return sumrect / vol / faces / Nc; // Nd , Nc dependent... FIXME + } + + ////////////////////////////////////////////////// + // the sum over all staples on each site + ////////////////////////////////////////////////// + static void RectStapleDouble(GaugeMat &U2, const GaugeMat &U, int mu) { + U2 = U * Cshift(U, mu, 1); } //////////////////////////////////////////////////////////////////////////// - // Hop by two optimisation strategy does not work nicely with Gparity. (could do, + // Hop by two optimisation strategy does not work nicely with Gparity. (could + // do, // but need to track two deep where cross boundary and apply a conjugation). - // Must differentiate this in Gimpl, and use Gimpl::isPeriodicGaugeField to do so . + // Must differentiate this in Gimpl, and use Gimpl::isPeriodicGaugeField to do + // so . //////////////////////////////////////////////////////////////////////////// - static void RectStapleOptimised(GaugeMat &Stap,std::vector &U2,std::vector &U,int mu){ + static void RectStapleOptimised(GaugeMat &Stap, std::vector &U2, + std::vector &U, int mu) { Stap = zero; GridBase *grid = U[0]._grid; - GaugeMat Staple2x1 (grid); - GaugeMat tmp (grid); + GaugeMat Staple2x1(grid); + GaugeMat tmp(grid); - for(int nu=0;nu &U2, - std::vector &U, int mu) - { - if ( Gimpl::isPeriodicGaugeField() ){ - RectStapleOptimised(Stap,U2,U,mu); - } else { - RectStapleUnoptimised(Stap,Umu,mu); + tmp = Gimpl::CovShiftBackward(U[mu], mu, U2[nu]); + tmp = adj(U2[nu]) * tmp; + tmp = Cshift(tmp, nu, -2); + Stap += Cshift(tmp, mu, 1); + } } } - static void RectStapleUnoptimised(GaugeMat &Stap,const GaugeLorentz &Umu,int mu){ + static void RectStaple(GaugeMat &Stap, const GaugeLorentz &Umu, int mu) { + RectStapleUnoptimised(Stap, Umu, mu); + } + static void RectStaple(const GaugeLorentz &Umu, GaugeMat &Stap, + std::vector &U2, std::vector &U, + int mu) { + if (Gimpl::isPeriodicGaugeField()) { + RectStapleOptimised(Stap, U2, U, mu); + } else { + RectStapleUnoptimised(Stap, Umu, mu); + } + } + + static void RectStapleUnoptimised(GaugeMat &Stap, const GaugeLorentz &Umu, + int mu) { GridBase *grid = Umu._grid; - std::vector U(Nd,grid); - for(int d=0;d(Umu,d); + std::vector U(Nd, grid); + for (int d = 0; d < Nd; d++) { + U[d] = PeekIndex(Umu, d); } - Stap=zero; + Stap = zero; - for(int nu=0;nu ColourWilsonLoops; - typedef WilsonLoops U1WilsonLoops; - typedef WilsonLoops SU2WilsonLoops; - typedef WilsonLoops SU3WilsonLoops; - -}} +typedef WilsonLoops ColourWilsonLoops; +typedef WilsonLoops U1WilsonLoops; +typedef WilsonLoops SU2WilsonLoops; +typedef WilsonLoops SU3WilsonLoops; +} +} #endif \ No newline at end of file