mirror of
https://github.com/paboyle/Grid.git
synced 2025-04-04 19:25:56 +01:00
Added generators for the adjoint representation
This commit is contained in:
parent
fbf96b1bbb
commit
5028969d4b
Binary file not shown.
Binary file not shown.
@ -25,7 +25,8 @@ Author: paboyle <paboyle@ph.ed.ac.uk>
|
|||||||
with this program; if not, write to the Free Software Foundation, Inc.,
|
with this program; if not, write to the Free Software Foundation, Inc.,
|
||||||
51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA.
|
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 */
|
/* END LEGAL */
|
||||||
//--------------------------------------------------------------------
|
//--------------------------------------------------------------------
|
||||||
@ -48,31 +49,24 @@ Author: paboyle <paboyle@ph.ed.ac.uk>
|
|||||||
namespace QCD {
|
namespace QCD {
|
||||||
|
|
||||||
struct IntegratorParameters {
|
struct IntegratorParameters {
|
||||||
|
|
||||||
int Nexp;
|
int Nexp;
|
||||||
int MDsteps; // number of outer steps
|
int MDsteps; // number of outer steps
|
||||||
RealD trajL; // trajectory length
|
RealD trajL; // trajectory length
|
||||||
RealD stepsize;
|
RealD stepsize;
|
||||||
|
|
||||||
IntegratorParameters(int MDsteps_,
|
IntegratorParameters(int MDsteps_, RealD trajL_ = 1.0, int Nexp_ = 12)
|
||||||
RealD trajL_=1.0,
|
: Nexp(Nexp_),
|
||||||
int Nexp_=12):
|
|
||||||
Nexp(Nexp_),
|
|
||||||
MDsteps(MDsteps_),
|
MDsteps(MDsteps_),
|
||||||
trajL(trajL_),
|
trajL(trajL_),
|
||||||
stepsize(trajL/MDsteps)
|
stepsize(trajL / MDsteps){
|
||||||
{
|
|
||||||
// empty body constructor
|
// empty body constructor
|
||||||
};
|
};
|
||||||
|
|
||||||
};
|
};
|
||||||
|
|
||||||
/*! @brief Class for Molecular Dynamics management */
|
/*! @brief Class for Molecular Dynamics management */
|
||||||
template <class GaugeField, class SmearingPolicy>
|
template <class GaugeField, class SmearingPolicy>
|
||||||
class Integrator {
|
class Integrator {
|
||||||
|
|
||||||
protected:
|
protected:
|
||||||
|
|
||||||
typedef IntegratorParameters ParameterType;
|
typedef IntegratorParameters ParameterType;
|
||||||
|
|
||||||
IntegratorParameters Params;
|
IntegratorParameters Params;
|
||||||
@ -89,17 +83,18 @@ Author: paboyle <paboyle@ph.ed.ac.uk>
|
|||||||
|
|
||||||
// Should match any legal (SU(n)) gauge field
|
// Should match any legal (SU(n)) gauge field
|
||||||
// Need to use this template to match Ncol to pass to SU<N> class
|
// Need to use this template to match Ncol to pass to SU<N> class
|
||||||
template<int Ncol,class vec> void generate_momenta(Lattice< iVector< iScalar< iMatrix<vec,Ncol> >, Nd> > & P,GridParallelRNG& pRNG){
|
template <int Ncol, class vec>
|
||||||
|
void generate_momenta(Lattice<iVector<iScalar<iMatrix<vec, Ncol> >, Nd> >& P,
|
||||||
|
GridParallelRNG& pRNG) {
|
||||||
typedef Lattice<iScalar<iScalar<iMatrix<vec, Ncol> > > > GaugeLinkField;
|
typedef Lattice<iScalar<iScalar<iMatrix<vec, Ncol> > > > GaugeLinkField;
|
||||||
GaugeLinkField Pmu(P._grid);
|
GaugeLinkField Pmu(P._grid);
|
||||||
Pmu = zero;
|
Pmu = zero;
|
||||||
for (int mu = 0; mu < Nd; mu++) {
|
for (int mu = 0; mu < Nd; mu++) {
|
||||||
SU<Ncol>::GaussianLieAlgebraMatrix(pRNG, Pmu);
|
SU<Ncol>::GaussianFundamentalLieAlgebraMatrix(pRNG, Pmu);
|
||||||
PokeIndex<LorentzIndex>(P, Pmu, mu);
|
PokeIndex<LorentzIndex>(P, Pmu, mu);
|
||||||
}
|
}
|
||||||
}
|
}
|
||||||
|
|
||||||
|
|
||||||
// ObserverList observers; // not yet
|
// ObserverList observers; // not yet
|
||||||
// typedef std::vector<Observer*> ObserverList;
|
// typedef std::vector<Observer*> ObserverList;
|
||||||
// void register_observers();
|
// void register_observers();
|
||||||
@ -109,7 +104,8 @@ Author: paboyle <paboyle@ph.ed.ac.uk>
|
|||||||
t_P[level] += ep;
|
t_P[level] += ep;
|
||||||
update_P(P, U, level, ep);
|
update_P(P, U, level, ep);
|
||||||
|
|
||||||
std::cout<<GridLogIntegrator<<"["<<level<<"] P " << " dt "<< ep <<" : t_P "<< t_P[level] <<std::endl;
|
std::cout << GridLogIntegrator << "[" << level << "] P "
|
||||||
|
<< " dt " << ep << " : t_P " << t_P[level] << std::endl;
|
||||||
}
|
}
|
||||||
|
|
||||||
void update_P(GaugeField& Mom, GaugeField& U, int level, double ep) {
|
void update_P(GaugeField& Mom, GaugeField& U, int level, double ep) {
|
||||||
@ -119,10 +115,14 @@ Author: paboyle <paboyle@ph.ed.ac.uk>
|
|||||||
GaugeField& Us = Smearer.get_U(as[level].actions.at(a)->is_smeared);
|
GaugeField& Us = Smearer.get_U(as[level].actions.at(a)->is_smeared);
|
||||||
as[level].actions.at(a)->deriv(Us, force); // deriv should NOT include Ta
|
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;
|
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);
|
if (as[level].actions.at(a)->is_smeared) Smearer.smeared_force(force);
|
||||||
force = Ta(force);
|
force = Ta(force);
|
||||||
std::cout<< GridLogIntegrator << "Force average: "<< norm2(force)/(U._grid->gSites()) <<std::endl;
|
std::cout << GridLogIntegrator
|
||||||
|
<< "Force average: " << norm2(force) / (U._grid->gSites())
|
||||||
|
<< std::endl;
|
||||||
Mom -= force * ep;
|
Mom -= force * ep;
|
||||||
}
|
}
|
||||||
}
|
}
|
||||||
@ -132,8 +132,9 @@ Author: paboyle <paboyle@ph.ed.ac.uk>
|
|||||||
|
|
||||||
t_U += ep;
|
t_U += ep;
|
||||||
int fl = levels - 1;
|
int fl = levels - 1;
|
||||||
std::cout<< GridLogIntegrator <<" "<<"["<<fl<<"] U " << " dt "<< ep <<" : t_U "<< t_U <<std::endl;
|
std::cout << GridLogIntegrator << " "
|
||||||
|
<< "[" << fl << "] U "
|
||||||
|
<< " dt " << ep << " : t_U " << t_U << std::endl;
|
||||||
}
|
}
|
||||||
void update_U(GaugeField& Mom, GaugeField& U, double ep) {
|
void update_U(GaugeField& Mom, GaugeField& U, double ep) {
|
||||||
// rewrite exponential to deal automatically with the lorentz index?
|
// rewrite exponential to deal automatically with the lorentz index?
|
||||||
@ -153,17 +154,9 @@ Author: paboyle <paboyle@ph.ed.ac.uk>
|
|||||||
virtual void step(GaugeField& U, int level, int first, int last) = 0;
|
virtual void step(GaugeField& U, int level, int first, int last) = 0;
|
||||||
|
|
||||||
public:
|
public:
|
||||||
|
Integrator(GridBase* grid, IntegratorParameters Par,
|
||||||
Integrator(GridBase* grid,
|
ActionSet<GaugeField>& Aset, SmearingPolicy& Sm)
|
||||||
IntegratorParameters Par,
|
: Params(Par), as(Aset), P(grid), levels(Aset.size()), Smearer(Sm) {
|
||||||
ActionSet<GaugeField> & Aset,
|
|
||||||
SmearingPolicy &Sm):
|
|
||||||
Params(Par),
|
|
||||||
as(Aset),
|
|
||||||
P(grid),
|
|
||||||
levels(Aset.size()),
|
|
||||||
Smearer(Sm)
|
|
||||||
{
|
|
||||||
t_P.resize(levels, 0.0);
|
t_P.resize(levels, 0.0);
|
||||||
t_U = 0.0;
|
t_U = 0.0;
|
||||||
// initialization of smearer delegated outside of Integrator
|
// initialization of smearer delegated outside of Integrator
|
||||||
@ -179,7 +172,8 @@ public:
|
|||||||
for (int actionID = 0; actionID < as[level].actions.size(); ++actionID) {
|
for (int actionID = 0; actionID < as[level].actions.size(); ++actionID) {
|
||||||
// get gauge field from the SmearingPolicy and
|
// get gauge field from the SmearingPolicy and
|
||||||
// based on the boolean is_smeared in actionID
|
// based on the boolean is_smeared in actionID
|
||||||
GaugeField& Us = Smearer.get_U(as[level].actions.at(actionID)->is_smeared);
|
GaugeField& Us =
|
||||||
|
Smearer.get_U(as[level].actions.at(actionID)->is_smeared);
|
||||||
as[level].actions.at(actionID)->refresh(Us, pRNG);
|
as[level].actions.at(actionID)->refresh(Us, pRNG);
|
||||||
}
|
}
|
||||||
}
|
}
|
||||||
@ -188,7 +182,8 @@ public:
|
|||||||
// Calculate action
|
// Calculate action
|
||||||
RealD S(GaugeField& U) { // here also U not used
|
RealD S(GaugeField& U) { // here also U not used
|
||||||
|
|
||||||
LatticeComplex Hloc(U._grid); Hloc = zero;
|
LatticeComplex Hloc(U._grid);
|
||||||
|
Hloc = zero;
|
||||||
// Momenta
|
// Momenta
|
||||||
for (int mu = 0; mu < Nd; mu++) {
|
for (int mu = 0; mu < Nd; mu++) {
|
||||||
auto Pmu = PeekIndex<LorentzIndex>(P, mu);
|
auto Pmu = PeekIndex<LorentzIndex>(P, mu);
|
||||||
@ -205,9 +200,11 @@ public:
|
|||||||
for (int actionID = 0; actionID < as[level].actions.size(); ++actionID) {
|
for (int actionID = 0; actionID < as[level].actions.size(); ++actionID) {
|
||||||
// get gauge field from the SmearingPolicy and
|
// get gauge field from the SmearingPolicy and
|
||||||
// based on the boolean is_smeared in actionID
|
// based on the boolean is_smeared in actionID
|
||||||
GaugeField& Us = Smearer.get_U(as[level].actions.at(actionID)->is_smeared);
|
GaugeField& Us =
|
||||||
|
Smearer.get_U(as[level].actions.at(actionID)->is_smeared);
|
||||||
Hterm = as[level].actions.at(actionID)->S(Us);
|
Hterm = as[level].actions.at(actionID)->S(Us);
|
||||||
std::cout<<GridLogMessage << "S Level "<<level<<" term "<<actionID<<" H = "<<Hterm<<std::endl;
|
std::cout << GridLogMessage << "S Level " << level << " term "
|
||||||
|
<< actionID << " H = " << Hterm << std::endl;
|
||||||
H += Hterm;
|
H += Hterm;
|
||||||
}
|
}
|
||||||
}
|
}
|
||||||
@ -216,7 +213,6 @@ public:
|
|||||||
}
|
}
|
||||||
|
|
||||||
void integrate(GaugeField& U) {
|
void integrate(GaugeField& U) {
|
||||||
|
|
||||||
// reset the clocks
|
// reset the clocks
|
||||||
t_U = 0;
|
t_U = 0;
|
||||||
for (int level = 0; level < as.size(); ++level) {
|
for (int level = 0; level < as.size(); ++level) {
|
||||||
@ -232,16 +228,14 @@ public:
|
|||||||
// Check the clocks all match on all levels
|
// Check the clocks all match on all levels
|
||||||
for (int level = 0; level < as.size(); ++level) {
|
for (int level = 0; level < as.size(); ++level) {
|
||||||
assert(fabs(t_U - t_P[level]) < 1.0e-6); // must be the same
|
assert(fabs(t_U - t_P[level]) < 1.0e-6); // must be the same
|
||||||
std::cout<<GridLogIntegrator<<" times["<<level<<"]= "<<t_P[level]<< " " << t_U <<std::endl;
|
std::cout << GridLogIntegrator << " times[" << level
|
||||||
|
<< "]= " << t_P[level] << " " << t_U << std::endl;
|
||||||
}
|
}
|
||||||
|
|
||||||
// and that we indeed got to the end of the trajectory
|
// and that we indeed got to the end of the trajectory
|
||||||
assert(fabs(t_U - Params.trajL) < 1.0e-6);
|
assert(fabs(t_U - Params.trajL) < 1.0e-6);
|
||||||
|
|
||||||
|
|
||||||
}
|
}
|
||||||
};
|
};
|
||||||
|
|
||||||
}
|
}
|
||||||
}
|
}
|
||||||
#endif // INTEGRATOR_INCLUDED
|
#endif // INTEGRATOR_INCLUDED
|
||||||
|
@ -25,7 +25,8 @@ Author: paboyle <paboyle@ph.ed.ac.uk>
|
|||||||
with this program; if not, write to the Free Software Foundation, Inc.,
|
with this program; if not, write to the Free Software Foundation, Inc.,
|
||||||
51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA.
|
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 */
|
/* END LEGAL */
|
||||||
#ifndef QCD_UTIL_SUN_H
|
#ifndef QCD_UTIL_SUN_H
|
||||||
@ -37,15 +38,19 @@ namespace Grid {
|
|||||||
template <int ncolour>
|
template <int ncolour>
|
||||||
class SU {
|
class SU {
|
||||||
public:
|
public:
|
||||||
|
|
||||||
static int generators(void) { return ncolour * ncolour - 1; }
|
static int generators(void) { return ncolour * ncolour - 1; }
|
||||||
static int su2subgroups(void) { return (ncolour * (ncolour - 1)) / 2; }
|
static int su2subgroups(void) { return (ncolour * (ncolour - 1)) / 2; }
|
||||||
|
|
||||||
template<typename vtype> using iSUnMatrix = iScalar<iScalar<iMatrix<vtype, ncolour> > > ;
|
template <typename vtype>
|
||||||
template<typename vtype> using iSU2Matrix = iScalar<iScalar<iMatrix<vtype, 2> > > ;
|
using iSUnMatrix = iScalar<iScalar<iMatrix<vtype, ncolour> > >;
|
||||||
|
template <typename vtype>
|
||||||
|
using iSU2Matrix = iScalar<iScalar<iMatrix<vtype, 2> > >;
|
||||||
|
template <typename vtype>
|
||||||
|
using iSUnAdjointMatrix = iScalar<iScalar<iMatrix<vtype, (ncolour*ncolour - 1)> > >;
|
||||||
|
|
||||||
//////////////////////////////////////////////////////////////////////////////////////////////////
|
//////////////////////////////////////////////////////////////////////////////////////////////////
|
||||||
// Types can be accessed as SU<2>::Matrix , SU<2>::vSUnMatrix, SU<2>::LatticeMatrix etc...
|
// Types can be accessed as SU<2>::Matrix , SU<2>::vSUnMatrix,
|
||||||
|
// SU<2>::LatticeMatrix etc...
|
||||||
//////////////////////////////////////////////////////////////////////////////////////////////////
|
//////////////////////////////////////////////////////////////////////////////////////////////////
|
||||||
typedef iSUnMatrix<Complex> Matrix;
|
typedef iSUnMatrix<Complex> Matrix;
|
||||||
typedef iSUnMatrix<ComplexF> MatrixF;
|
typedef iSUnMatrix<ComplexF> MatrixF;
|
||||||
@ -55,6 +60,16 @@ public:
|
|||||||
typedef iSUnMatrix<vComplexF> vMatrixF;
|
typedef iSUnMatrix<vComplexF> vMatrixF;
|
||||||
typedef iSUnMatrix<vComplexD> vMatrixD;
|
typedef iSUnMatrix<vComplexD> vMatrixD;
|
||||||
|
|
||||||
|
// Actually the adjoint matrices are real...
|
||||||
|
// Consider this overhead... FIXME
|
||||||
|
typedef iSUnAdjointMatrix<Complex> AMatrix;
|
||||||
|
typedef iSUnAdjointMatrix<ComplexF> AMatrixF;
|
||||||
|
typedef iSUnAdjointMatrix<ComplexD> AMatrixD;
|
||||||
|
|
||||||
|
typedef iSUnAdjointMatrix<vComplex> vAMatrix;
|
||||||
|
typedef iSUnAdjointMatrix<vComplexF> vAMatrixF;
|
||||||
|
typedef iSUnAdjointMatrix<vComplexD> vAMatrixD;
|
||||||
|
|
||||||
typedef Lattice<vMatrix> LatticeMatrix;
|
typedef Lattice<vMatrix> LatticeMatrix;
|
||||||
typedef Lattice<vMatrixF> LatticeMatrixF;
|
typedef Lattice<vMatrixF> LatticeMatrixF;
|
||||||
typedef Lattice<vMatrixD> LatticeMatrixD;
|
typedef Lattice<vMatrixD> LatticeMatrixD;
|
||||||
@ -71,13 +86,13 @@ public:
|
|||||||
typedef Lattice<vSU2MatrixF> LatticeSU2MatrixF;
|
typedef Lattice<vSU2MatrixF> LatticeSU2MatrixF;
|
||||||
typedef Lattice<vSU2MatrixD> LatticeSU2MatrixD;
|
typedef Lattice<vSU2MatrixD> LatticeSU2MatrixD;
|
||||||
|
|
||||||
|
|
||||||
////////////////////////////////////////////////////////////////////////
|
////////////////////////////////////////////////////////////////////////
|
||||||
// There are N^2-1 generators for SU(N).
|
// There are N^2-1 generators for SU(N).
|
||||||
//
|
//
|
||||||
// We take a traceless hermitian generator basis as follows
|
// We take a traceless hermitian generator basis as follows
|
||||||
//
|
//
|
||||||
// * Normalisation: trace ta tb = 1/2 delta_ab
|
// * Normalisation: trace ta tb = 1/2 delta_ab = T_F delta_ab
|
||||||
|
// T_F = 1/2 for SU(N) groups
|
||||||
//
|
//
|
||||||
// * Off diagonal
|
// * Off diagonal
|
||||||
// - pairs of rows i1,i2 behaving like pauli matrices signma_x, sigma_y
|
// - pairs of rows i1,i2 behaving like pauli matrices signma_x, sigma_y
|
||||||
@ -93,11 +108,14 @@ public:
|
|||||||
// - There are 2 x Nc (Nc-1)/ 2 of these = Nc^2 - Nc
|
// - There are 2 x Nc (Nc-1)/ 2 of these = Nc^2 - Nc
|
||||||
//
|
//
|
||||||
// - We enumerate the row-col pairs.
|
// - We enumerate the row-col pairs.
|
||||||
// - for each row col pair there is a (sigma_x) and a (sigma_y) like generator
|
// - for each row col pair there is a (sigma_x) and a (sigma_y) like
|
||||||
|
// generator
|
||||||
//
|
//
|
||||||
//
|
//
|
||||||
// t^a_ij = { in 0.. Nc(Nc-1)/2 -1} => delta_{i,i1} delta_{j,i2} + delta_{i,i1} delta_{j,i2}
|
// t^a_ij = { in 0.. Nc(Nc-1)/2 -1} => 1/2(delta_{i,i1} delta_{j,i2} +
|
||||||
// t^a_ij = { in Nc(Nc-1)/2 ... Nc^(Nc-1) -1} => i delta_{i,i1} delta_{j,i2} - i delta_{i,i1} delta_{j,i2}
|
// delta_{i,i1} delta_{j,i2})
|
||||||
|
// t^a_ij = { in Nc(Nc-1)/2 ... Nc(Nc-1) - 1} => i/2( delta_{i,i1}
|
||||||
|
// delta_{j,i2} - i delta_{i,i1} delta_{j,i2})
|
||||||
//
|
//
|
||||||
// * Diagonal; must be traceless and normalised
|
// * Diagonal; must be traceless and normalised
|
||||||
// - Sequence is
|
// - Sequence is
|
||||||
@ -114,6 +132,20 @@ public:
|
|||||||
// ( 1 )
|
// ( 1 )
|
||||||
// ( 1 ) / sqrt(3) /2 = 1/2 lambda_8
|
// ( 1 ) / sqrt(3) /2 = 1/2 lambda_8
|
||||||
// ( -2)
|
// ( -2)
|
||||||
|
//
|
||||||
|
//
|
||||||
|
// * Adjoint representation generators
|
||||||
|
//
|
||||||
|
// base for NxN hermitian traceless matrices
|
||||||
|
// normalized to 1:
|
||||||
|
//
|
||||||
|
// (e_Adj)^a = t^a / sqrt(T_F)
|
||||||
|
//
|
||||||
|
// then the real, antisymmetric generators for the adjoint representations
|
||||||
|
// are computed ( shortcut: e^a == (e_Adj)^a )
|
||||||
|
//
|
||||||
|
// (iT_adj)^d_ab = i tr[e^a t^d e^b - t^d e^a e^b]
|
||||||
|
//
|
||||||
////////////////////////////////////////////////////////////////////////
|
////////////////////////////////////////////////////////////////////////
|
||||||
template <class cplx>
|
template <class cplx>
|
||||||
static void generator(int lieIndex, iSUnMatrix<cplx> &ta) {
|
static void generator(int lieIndex, iSUnMatrix<cplx> &ta) {
|
||||||
@ -127,10 +159,12 @@ public:
|
|||||||
generatorDiagonal(diagIndex, ta);
|
generatorDiagonal(diagIndex, ta);
|
||||||
return;
|
return;
|
||||||
}
|
}
|
||||||
sigxy = lieIndex&0x1;
|
sigxy = lieIndex & 0x1;//even or odd
|
||||||
su2Index = lieIndex >> 1;
|
su2Index = lieIndex >> 1;
|
||||||
if ( sigxy ) generatorSigmaY(su2Index,ta);
|
if (sigxy)
|
||||||
else generatorSigmaX(su2Index,ta);
|
generatorSigmaY(su2Index, ta);
|
||||||
|
else
|
||||||
|
generatorSigmaX(su2Index, ta);
|
||||||
}
|
}
|
||||||
template <class cplx>
|
template <class cplx>
|
||||||
static void generatorSigmaX(int su2Index, iSUnMatrix<cplx> &ta) {
|
static void generatorSigmaX(int su2Index, iSUnMatrix<cplx> &ta) {
|
||||||
@ -153,24 +187,45 @@ public:
|
|||||||
}
|
}
|
||||||
template <class cplx>
|
template <class cplx>
|
||||||
static void generatorDiagonal(int diagIndex, iSUnMatrix<cplx> &ta) {
|
static void generatorDiagonal(int diagIndex, iSUnMatrix<cplx> &ta) {
|
||||||
|
// diag ({1, 1, ..., 1}(k-times), -k, 0, 0, ...)
|
||||||
ta = zero;
|
ta = zero;
|
||||||
int trsq=0;
|
int k = diagIndex + 1;// diagIndex starts from 0
|
||||||
int last=diagIndex+1;
|
for (int i = 0; i <= diagIndex; i++) {// k iterations
|
||||||
for(int i=0;i<=diagIndex;i++){
|
|
||||||
ta()()(i, i) = 1.0;
|
ta()()(i, i) = 1.0;
|
||||||
trsq++;
|
|
||||||
}
|
}
|
||||||
ta()()(last,last) = -last;
|
ta()()(k,k) = -k;//indexing starts from 0
|
||||||
trsq+=last*last;
|
RealD nrm = 1.0 / std::sqrt(2.0 * k*(k+1));
|
||||||
RealD nrm = 1.0/std::sqrt(2.0*trsq);
|
|
||||||
ta = ta * nrm;
|
ta = ta * nrm;
|
||||||
}
|
}
|
||||||
|
|
||||||
|
template <class cplx>
|
||||||
|
static void generatorAdjoint(int Index, iSUnAdjointMatrix<cplx> &iAdjTa){
|
||||||
|
// returns i(T_Adj)^index necessary for the projectors
|
||||||
|
// see definitions above
|
||||||
|
iAdjTa = zero;
|
||||||
|
Vector< iSUnMatrix<cplx> > ta(ncolour*ncolour -1);
|
||||||
|
iSUnMatrix<cplx> tmp;
|
||||||
|
|
||||||
|
// FIXME not very efficient to get all the generators everytime
|
||||||
|
for (int a = 0; a < (ncolour * ncolour - 1); a++)
|
||||||
|
generator(a, ta[a]);
|
||||||
|
|
||||||
|
|
||||||
|
for (int a = 0; a < (ncolour*ncolour - 1); a++){
|
||||||
|
tmp = ta[a] * ta[Index] - ta[Index] * ta[a];
|
||||||
|
for (int b = 0; b < (ncolour*ncolour - 1); b++){
|
||||||
|
iSUnMatrix<cplx> tmp1 = 2.0 * tmp * ta[b]; // 2.0 from the normalization
|
||||||
|
Complex iTr = TensorRemove(timesI(trace(tmp1)));
|
||||||
|
iAdjTa()()(b,a) = iTr;
|
||||||
|
}
|
||||||
|
}
|
||||||
|
|
||||||
|
|
||||||
|
}
|
||||||
////////////////////////////////////////////////////////////////////////
|
////////////////////////////////////////////////////////////////////////
|
||||||
// Map a su2 subgroup number to the pair of rows that are non zero
|
// Map a su2 subgroup number to the pair of rows that are non zero
|
||||||
////////////////////////////////////////////////////////////////////////
|
////////////////////////////////////////////////////////////////////////
|
||||||
static void su2SubGroupIndex(int &i1, int &i2, int su2_index) {
|
static void su2SubGroupIndex(int &i1, int &i2, int su2_index) {
|
||||||
|
|
||||||
assert((su2_index >= 0) && (su2_index < (ncolour * (ncolour - 1)) / 2));
|
assert((su2_index >= 0) && (su2_index < (ncolour * (ncolour - 1)) / 2));
|
||||||
|
|
||||||
int spare = su2_index;
|
int spare = su2_index;
|
||||||
@ -187,8 +242,7 @@ public:
|
|||||||
static void su2Extract(Lattice<iSinglet<vcplx> > &Determinant,
|
static void su2Extract(Lattice<iSinglet<vcplx> > &Determinant,
|
||||||
Lattice<iSU2Matrix<vcplx> > &subgroup,
|
Lattice<iSU2Matrix<vcplx> > &subgroup,
|
||||||
const Lattice<iSUnMatrix<vcplx> > &source,
|
const Lattice<iSUnMatrix<vcplx> > &source,
|
||||||
int su2_index)
|
int su2_index) {
|
||||||
{
|
|
||||||
GridBase *grid(source._grid);
|
GridBase *grid(source._grid);
|
||||||
conformable(subgroup, source);
|
conformable(subgroup, source);
|
||||||
conformable(subgroup, Determinant);
|
conformable(subgroup, Determinant);
|
||||||
@ -209,11 +263,9 @@ PARALLEL_FOR_LOOP
|
|||||||
subgroup._odata[ss] = Sigma;
|
subgroup._odata[ss] = Sigma;
|
||||||
|
|
||||||
// this should be purely real
|
// this should be purely real
|
||||||
Determinant._odata[ss] = Sigma()()(0,0)*Sigma()()(1,1)
|
Determinant._odata[ss] =
|
||||||
- Sigma()()(0,1)*Sigma()()(1,0);
|
Sigma()()(0, 0) * Sigma()()(1, 1) - Sigma()()(0, 1) * Sigma()()(1, 0);
|
||||||
|
|
||||||
}
|
}
|
||||||
|
|
||||||
}
|
}
|
||||||
|
|
||||||
//////////////////////////////////////////////////////////////////////////////////////////
|
//////////////////////////////////////////////////////////////////////////////////////////
|
||||||
@ -221,9 +273,7 @@ PARALLEL_FOR_LOOP
|
|||||||
//////////////////////////////////////////////////////////////////////////////////////////
|
//////////////////////////////////////////////////////////////////////////////////////////
|
||||||
template <class vcplx>
|
template <class vcplx>
|
||||||
static void su2Insert(const Lattice<iSU2Matrix<vcplx> > &subgroup,
|
static void su2Insert(const Lattice<iSU2Matrix<vcplx> > &subgroup,
|
||||||
Lattice<iSUnMatrix<vcplx> > &dest,
|
Lattice<iSUnMatrix<vcplx> > &dest, int su2_index) {
|
||||||
int su2_index)
|
|
||||||
{
|
|
||||||
GridBase *grid(dest._grid);
|
GridBase *grid(dest._grid);
|
||||||
conformable(subgroup, dest);
|
conformable(subgroup, dest);
|
||||||
int i0, i1;
|
int i0, i1;
|
||||||
@ -239,24 +289,22 @@ PARALLEL_FOR_LOOP
|
|||||||
}
|
}
|
||||||
}
|
}
|
||||||
|
|
||||||
|
|
||||||
///////////////////////////////////////////////
|
///////////////////////////////////////////////
|
||||||
// Generate e^{ Re Tr Staple Link} dlink
|
// Generate e^{ Re Tr Staple Link} dlink
|
||||||
//
|
//
|
||||||
// *** Note Staple should be appropriate linear compbination between all staples.
|
// *** Note Staple should be appropriate linear compbination between all
|
||||||
|
// staples.
|
||||||
// *** If already by beta pass coefficient 1.0.
|
// *** If already by beta pass coefficient 1.0.
|
||||||
// *** This routine applies the additional 1/Nc factor that comes after trace in action.
|
// *** This routine applies the additional 1/Nc factor that comes after trace
|
||||||
|
// in action.
|
||||||
//
|
//
|
||||||
///////////////////////////////////////////////
|
///////////////////////////////////////////////
|
||||||
static void SubGroupHeatBath( GridSerialRNG &sRNG,
|
static void SubGroupHeatBath(
|
||||||
GridParallelRNG &pRNG,
|
GridSerialRNG &sRNG, GridParallelRNG &pRNG,
|
||||||
RealD beta, // coeff multiplying staple in action (with no 1/Nc)
|
RealD beta, // coeff multiplying staple in action (with no 1/Nc)
|
||||||
LatticeMatrix &link,
|
LatticeMatrix &link,
|
||||||
const LatticeMatrix &barestaple, // multiplied by action coeffs so th
|
const LatticeMatrix &barestaple, // multiplied by action coeffs so th
|
||||||
int su2_subgroup,
|
int su2_subgroup, int nheatbath, LatticeInteger &wheremask) {
|
||||||
int nheatbath,
|
|
||||||
LatticeInteger &wheremask)
|
|
||||||
{
|
|
||||||
GridBase *grid = link._grid;
|
GridBase *grid = link._grid;
|
||||||
|
|
||||||
int ntrials = 0;
|
int ntrials = 0;
|
||||||
@ -267,22 +315,30 @@ PARALLEL_FOR_LOOP
|
|||||||
|
|
||||||
staple = barestaple * (beta / ncolour);
|
staple = barestaple * (beta / ncolour);
|
||||||
|
|
||||||
LatticeMatrix V(grid); V = link*staple;
|
LatticeMatrix V(grid);
|
||||||
|
V = link * staple;
|
||||||
|
|
||||||
// Subgroup manipulation in the lie algebra space
|
// Subgroup manipulation in the lie algebra space
|
||||||
LatticeSU2Matrix u(grid); // Kennedy pendleton "u" real projected normalised Sigma
|
LatticeSU2Matrix u(
|
||||||
|
grid); // Kennedy pendleton "u" real projected normalised Sigma
|
||||||
LatticeSU2Matrix uinv(grid);
|
LatticeSU2Matrix uinv(grid);
|
||||||
LatticeSU2Matrix ua(grid); // a in pauli form
|
LatticeSU2Matrix ua(grid); // a in pauli form
|
||||||
LatticeSU2Matrix b(grid); // rotated matrix after hb
|
LatticeSU2Matrix b(grid); // rotated matrix after hb
|
||||||
|
|
||||||
// Some handy constant fields
|
// Some handy constant fields
|
||||||
LatticeComplex ones (grid); ones = 1.0;
|
LatticeComplex ones(grid);
|
||||||
LatticeComplex zeros(grid); zeros=zero;
|
ones = 1.0;
|
||||||
LatticeReal rones (grid); rones = 1.0;
|
LatticeComplex zeros(grid);
|
||||||
LatticeReal rzeros(grid); rzeros=zero;
|
zeros = zero;
|
||||||
|
LatticeReal rones(grid);
|
||||||
|
rones = 1.0;
|
||||||
|
LatticeReal rzeros(grid);
|
||||||
|
rzeros = zero;
|
||||||
LatticeComplex udet(grid); // determinant of real(staple)
|
LatticeComplex udet(grid); // determinant of real(staple)
|
||||||
LatticeInteger mask_true (grid); mask_true = 1;
|
LatticeInteger mask_true(grid);
|
||||||
LatticeInteger mask_false(grid); mask_false= 0;
|
mask_true = 1;
|
||||||
|
LatticeInteger mask_false(grid);
|
||||||
|
mask_false = 0;
|
||||||
|
|
||||||
/*
|
/*
|
||||||
PLB 156 P393 (1985) (Kennedy and Pendleton)
|
PLB 156 P393 (1985) (Kennedy and Pendleton)
|
||||||
@ -299,7 +355,8 @@ Writing Sigma = 1/Nc (beta Sigma') where sum over staples is "Sigma' "
|
|||||||
beta S = const - beta/Nc Re Tr h Sigma'
|
beta S = const - beta/Nc Re Tr h Sigma'
|
||||||
= const - Re Tr h Sigma
|
= const - Re Tr h Sigma
|
||||||
|
|
||||||
Decompose h and Sigma into (1, sigma_j) ; h_i real, h^2=1, Sigma_i complex arbitrary.
|
Decompose h and Sigma into (1, sigma_j) ; h_i real, h^2=1, Sigma_i complex
|
||||||
|
arbitrary.
|
||||||
|
|
||||||
Tr h Sigma = h_i Sigma_j Tr (sigma_i sigma_j) = h_i Sigma_j 2 delta_ij
|
Tr h Sigma = h_i Sigma_j Tr (sigma_i sigma_j) = h_i Sigma_j 2 delta_ij
|
||||||
Re Tr h Sigma = 2 h_j Re Sigma_j
|
Re Tr h Sigma = 2 h_j Re Sigma_j
|
||||||
@ -335,9 +392,12 @@ Note: Product b' xi is unvariant because scaling Sigma leaves
|
|||||||
LatticeSU2Matrix lident(grid);
|
LatticeSU2Matrix lident(grid);
|
||||||
|
|
||||||
SU2Matrix ident = Complex(1.0);
|
SU2Matrix ident = Complex(1.0);
|
||||||
SU2Matrix pauli1; SU<2>::generator(0,pauli1);
|
SU2Matrix pauli1;
|
||||||
SU2Matrix pauli2; SU<2>::generator(1,pauli2);
|
SU<2>::generator(0, pauli1);
|
||||||
SU2Matrix pauli3; SU<2>::generator(2,pauli3);
|
SU2Matrix pauli2;
|
||||||
|
SU<2>::generator(1, pauli2);
|
||||||
|
SU2Matrix pauli3;
|
||||||
|
SU<2>::generator(2, pauli3);
|
||||||
pauli1 = timesI(pauli1) * 2.0;
|
pauli1 = timesI(pauli1) * 2.0;
|
||||||
pauli2 = timesI(pauli2) * 2.0;
|
pauli2 = timesI(pauli2) * 2.0;
|
||||||
pauli3 = timesI(pauli3) * 2.0;
|
pauli3 = timesI(pauli3) * 2.0;
|
||||||
@ -352,7 +412,8 @@ Note: Product b' xi is unvariant because scaling Sigma leaves
|
|||||||
udet = where(adet > machine_epsilon, udet, cone);
|
udet = where(adet > machine_epsilon, udet, cone);
|
||||||
|
|
||||||
xi = 0.5 * sqrt(udet); // 4xi^2 = Det [ Sig - Sig^dag + 1 Tr Sigdag]
|
xi = 0.5 * sqrt(udet); // 4xi^2 = Det [ Sig - Sig^dag + 1 Tr Sigdag]
|
||||||
u = 0.5*u*pow(xi,-1.0); // u = 1/2xi [ Sig - Sig^dag + 1 Tr Sigdag]
|
u = 0.5 * u *
|
||||||
|
pow(xi, -1.0); // u = 1/2xi [ Sig - Sig^dag + 1 Tr Sigdag]
|
||||||
|
|
||||||
// Debug test for sanity
|
// Debug test for sanity
|
||||||
uinv = adj(u);
|
uinv = adj(u);
|
||||||
@ -363,19 +424,24 @@ Note: Product b' xi is unvariant because scaling Sigma leaves
|
|||||||
Measure: Haar measure dh has d^4a delta(1-|a^2|)
|
Measure: Haar measure dh has d^4a delta(1-|a^2|)
|
||||||
In polars:
|
In polars:
|
||||||
da = da0 r^2 sin theta dr dtheta dphi delta( 1 - r^2 -a0^2)
|
da = da0 r^2 sin theta dr dtheta dphi delta( 1 - r^2 -a0^2)
|
||||||
= da0 r^2 sin theta dr dtheta dphi delta( (sqrt(1-a0^) - r)(sqrt(1-a0^) + r) )
|
= da0 r^2 sin theta dr dtheta dphi delta( (sqrt(1-a0^) - r)(sqrt(1-a0^) +
|
||||||
|
r) )
|
||||||
= da0 r/2 sin theta dr dtheta dphi delta( (sqrt(1-a0^) - r) )
|
= da0 r/2 sin theta dr dtheta dphi delta( (sqrt(1-a0^) - r) )
|
||||||
|
|
||||||
Action factor Q(h) dh = e^-S[h] dh = e^{ xi Tr uh} dh // beta enters through xi
|
Action factor Q(h) dh = e^-S[h] dh = e^{ xi Tr uh} dh // beta enters
|
||||||
|
through xi
|
||||||
= e^{2 xi (h.u)} dh
|
= e^{2 xi (h.u)} dh
|
||||||
= e^{2 xi h0u0}.e^{2 xi h1u1}.e^{2 xi h2u2}.e^{2 xi h3u3} dh
|
= e^{2 xi h0u0}.e^{2 xi h1u1}.e^{2 xi
|
||||||
|
h2u2}.e^{2 xi h3u3} dh
|
||||||
|
|
||||||
Therefore for each site, take xi for that site
|
Therefore for each site, take xi for that site
|
||||||
i) generate |a0|<1 with dist
|
i) generate |a0|<1 with dist
|
||||||
(1-a0^2)^0.5 e^{2 xi a0 } da0
|
(1-a0^2)^0.5 e^{2 xi a0 } da0
|
||||||
|
|
||||||
Take alpha = 2 xi = 2 xi [ recall 2 beta/Nc unmod staple norm]; hence 2.0/Nc factor in Chroma ]
|
Take alpha = 2 xi = 2 xi [ recall 2 beta/Nc unmod staple norm]; hence 2.0/Nc
|
||||||
A. Generate two uniformly distributed pseudo-random numbers R and R', R'', R''' in the unit interval;
|
factor in Chroma ]
|
||||||
|
A. Generate two uniformly distributed pseudo-random numbers R and R', R'',
|
||||||
|
R''' in the unit interval;
|
||||||
B. Set X = -(ln R)/alpha, X' =-(ln R')/alpha;
|
B. Set X = -(ln R)/alpha, X' =-(ln R')/alpha;
|
||||||
C. Set C = cos^2(2pi R"), with R" another uniform random number in [0,1] ;
|
C. Set C = cos^2(2pi R"), with R" another uniform random number in [0,1] ;
|
||||||
D. Set A = XC;
|
D. Set A = XC;
|
||||||
@ -383,7 +449,8 @@ E. Let d = X'+A;
|
|||||||
F. If R'''^2 :> 1 - 0.5 d, go back to A;
|
F. If R'''^2 :> 1 - 0.5 d, go back to A;
|
||||||
G. Set a0 = 1 - d;
|
G. Set a0 = 1 - d;
|
||||||
|
|
||||||
Note that in step D setting B ~ X - A and using B in place of A in step E will generate a second independent a 0 value.
|
Note that in step D setting B ~ X - A and using B in place of A in step E will
|
||||||
|
generate a second independent a 0 value.
|
||||||
*/
|
*/
|
||||||
|
|
||||||
/////////////////////////////////////////////////////////
|
/////////////////////////////////////////////////////////
|
||||||
@ -394,20 +461,22 @@ Note that in step D setting B ~ X - A and using B in place of A in step E will g
|
|||||||
rtmp = where(wheremask, rones, rzeros);
|
rtmp = where(wheremask, rones, rzeros);
|
||||||
RealD numSites = sum(rtmp);
|
RealD numSites = sum(rtmp);
|
||||||
RealD numAccepted;
|
RealD numAccepted;
|
||||||
LatticeInteger Accepted(grid); Accepted = zero;
|
LatticeInteger Accepted(grid);
|
||||||
|
Accepted = zero;
|
||||||
LatticeInteger newlyAccepted(grid);
|
LatticeInteger newlyAccepted(grid);
|
||||||
|
|
||||||
std::vector<LatticeReal> xr(4, grid);
|
std::vector<LatticeReal> xr(4, grid);
|
||||||
std::vector<LatticeReal> a(4, grid);
|
std::vector<LatticeReal> a(4, grid);
|
||||||
LatticeReal d(grid); d=zero;
|
LatticeReal d(grid);
|
||||||
|
d = zero;
|
||||||
LatticeReal alpha(grid);
|
LatticeReal alpha(grid);
|
||||||
|
|
||||||
// std::cout<<GridLogMessage<<"xi "<<xi <<std::endl;
|
// std::cout<<GridLogMessage<<"xi "<<xi <<std::endl;
|
||||||
alpha = toReal(2.0 * xi);
|
alpha = toReal(2.0 * xi);
|
||||||
|
|
||||||
do {
|
do {
|
||||||
|
// A. Generate two uniformly distributed pseudo-random numbers R and R',
|
||||||
// A. Generate two uniformly distributed pseudo-random numbers R and R', R'', R''' in the unit interval;
|
// R'', R''' in the unit interval;
|
||||||
random(pRNG, xr[0]);
|
random(pRNG, xr[0]);
|
||||||
random(pRNG, xr[1]);
|
random(pRNG, xr[1]);
|
||||||
random(pRNG, xr[2]);
|
random(pRNG, xr[2]);
|
||||||
@ -430,10 +499,13 @@ Note that in step D setting B ~ X - A and using B in place of A in step E will g
|
|||||||
d = where(Accepted, d, xr[2] + xr[1] * xr[3]);
|
d = where(Accepted, d, xr[2] + xr[1] * xr[3]);
|
||||||
|
|
||||||
// F. If R'''^2 :> 1 - 0.5 d, go back to A;
|
// F. If R'''^2 :> 1 - 0.5 d, go back to A;
|
||||||
LatticeReal thresh(grid); thresh = 1.0-d*0.5;
|
LatticeReal thresh(grid);
|
||||||
|
thresh = 1.0 - d * 0.5;
|
||||||
xrsq = xr[0] * xr[0];
|
xrsq = xr[0] * xr[0];
|
||||||
LatticeInteger ione(grid); ione = 1;
|
LatticeInteger ione(grid);
|
||||||
LatticeInteger izero(grid); izero=zero;
|
ione = 1;
|
||||||
|
LatticeInteger izero(grid);
|
||||||
|
izero = zero;
|
||||||
|
|
||||||
newlyAccepted = where(xrsq < thresh, ione, izero);
|
newlyAccepted = where(xrsq < thresh, ione, izero);
|
||||||
Accepted = where(newlyAccepted, newlyAccepted, Accepted);
|
Accepted = where(newlyAccepted, newlyAccepted, Accepted);
|
||||||
@ -462,18 +534,18 @@ Note that in step D setting B ~ X - A and using B in place of A in step E will g
|
|||||||
LatticeReal sin_theta(grid);
|
LatticeReal sin_theta(grid);
|
||||||
LatticeReal phi(grid);
|
LatticeReal phi(grid);
|
||||||
|
|
||||||
random(pRNG,phi); phi = phi * twopi; // uniform in [0,2pi]
|
random(pRNG, phi);
|
||||||
random(pRNG,cos_theta); cos_theta=(cos_theta*2.0)-1.0; // uniform in [-1,1]
|
phi = phi * twopi; // uniform in [0,2pi]
|
||||||
|
random(pRNG, cos_theta);
|
||||||
|
cos_theta = (cos_theta * 2.0) - 1.0; // uniform in [-1,1]
|
||||||
sin_theta = sqrt(abs(1.0 - cos_theta * cos_theta));
|
sin_theta = sqrt(abs(1.0 - cos_theta * cos_theta));
|
||||||
|
|
||||||
a[1] = a123mag * sin_theta * cos(phi);
|
a[1] = a123mag * sin_theta * cos(phi);
|
||||||
a[2] = a123mag * sin_theta * sin(phi);
|
a[2] = a123mag * sin_theta * sin(phi);
|
||||||
a[3] = a123mag * cos_theta;
|
a[3] = a123mag * cos_theta;
|
||||||
|
|
||||||
ua = toComplex(a[0])*ident
|
ua = toComplex(a[0]) * ident + toComplex(a[1]) * pauli1 +
|
||||||
+ toComplex(a[1])*pauli1
|
toComplex(a[2]) * pauli2 + toComplex(a[3]) * pauli3;
|
||||||
+ toComplex(a[2])*pauli2
|
|
||||||
+ toComplex(a[3])*pauli3;
|
|
||||||
|
|
||||||
b = 1.0;
|
b = 1.0;
|
||||||
b = where(wheremask, uinv * ua, b);
|
b = where(wheremask, uinv * ua, b);
|
||||||
@ -508,52 +580,87 @@ Note that in step D setting B ~ X - A and using B in place of A in step E will g
|
|||||||
/////////////////////////////////
|
/////////////////////////////////
|
||||||
}
|
}
|
||||||
|
|
||||||
static void printGenerators(void)
|
static void printGenerators(void) {
|
||||||
{
|
|
||||||
for (int gen = 0; gen < generators(); gen++) {
|
for (int gen = 0; gen < generators(); gen++) {
|
||||||
Matrix ta;
|
Matrix ta;
|
||||||
generator(gen, ta);
|
generator(gen, ta);
|
||||||
std::cout<<GridLogMessage<< "Nc = "<<ncolour<<" t_"<<gen<<std::endl;
|
std::cout << GridLogMessage << "Nc = " << ncolour << " t_" << gen
|
||||||
|
<< std::endl;
|
||||||
std::cout << GridLogMessage << ta << std::endl;
|
std::cout << GridLogMessage << ta << std::endl;
|
||||||
}
|
}
|
||||||
}
|
}
|
||||||
|
|
||||||
|
static void printAdjointGenerators(void) {
|
||||||
|
for (int gen = 0; gen < generators(); gen++) {
|
||||||
|
AMatrix ta;
|
||||||
|
generatorAdjoint(gen, ta);
|
||||||
|
std::cout << GridLogMessage << "Nc = " << ncolour << " t_" << gen
|
||||||
|
<< std::endl;
|
||||||
|
std::cout << GridLogMessage << ta << std::endl;
|
||||||
|
}
|
||||||
|
}
|
||||||
|
|
||||||
|
|
||||||
|
|
||||||
static void testGenerators(void) {
|
static void testGenerators(void) {
|
||||||
Matrix ta;
|
Matrix ta;
|
||||||
Matrix tb;
|
Matrix tb;
|
||||||
std::cout<<GridLogMessage<<"Checking trace ta tb is 0.5 delta_ab"<<std::endl;
|
std::cout << GridLogMessage << "Fundamental - Checking trace ta tb is 0.5 delta_ab"
|
||||||
|
<< std::endl;
|
||||||
for (int a = 0; a < generators(); a++) {
|
for (int a = 0; a < generators(); a++) {
|
||||||
for (int b = 0; b < generators(); b++) {
|
for (int b = 0; b < generators(); b++) {
|
||||||
generator(a, ta);
|
generator(a, ta);
|
||||||
generator(b, tb);
|
generator(b, tb);
|
||||||
Complex tr = TensorRemove(trace(ta * tb));
|
Complex tr = TensorRemove(trace(ta * tb));
|
||||||
std::cout<<GridLogMessage<<tr<<" ";
|
std::cout << GridLogMessage << "("<< a << "," << b << ") = "<< tr << std::endl;
|
||||||
if (a == b) assert(abs(tr - Complex(0.5)) < 1.0e-6);
|
if (a == b) assert(abs(tr - Complex(0.5)) < 1.0e-6);
|
||||||
if (a != b) assert(abs(tr) < 1.0e-6);
|
if (a != b) assert(abs(tr) < 1.0e-6);
|
||||||
}
|
}
|
||||||
std::cout << GridLogMessage << std::endl;
|
std::cout << GridLogMessage << std::endl;
|
||||||
}
|
}
|
||||||
std::cout<<GridLogMessage<<"Checking hermitian"<<std::endl;
|
std::cout << GridLogMessage << "Fundamental - Checking if hermitian" << std::endl;
|
||||||
for (int a = 0; a < generators(); a++) {
|
for (int a = 0; a < generators(); a++) {
|
||||||
generator(a, ta);
|
generator(a, ta);
|
||||||
std::cout<<GridLogMessage<<a<<" ";
|
std::cout << GridLogMessage << a << std::endl;
|
||||||
assert(norm2(ta - adj(ta)) < 1.0e-6) ;
|
assert(norm2(ta - adj(ta)) < 1.0e-6) ;
|
||||||
}
|
}
|
||||||
std::cout << GridLogMessage << std::endl;
|
std::cout << GridLogMessage << std::endl;
|
||||||
|
|
||||||
std::cout<<GridLogMessage<<"Checking traceless"<<std::endl;
|
std::cout << GridLogMessage << "Fundamental - Checking if traceless" << std::endl;
|
||||||
for (int a = 0; a < generators(); a++) {
|
for (int a = 0; a < generators(); a++) {
|
||||||
generator(a, ta);
|
generator(a, ta);
|
||||||
Complex tr = TensorRemove(trace(ta));
|
Complex tr = TensorRemove(trace(ta));
|
||||||
std::cout<<GridLogMessage<<a<<" ";
|
std::cout << GridLogMessage << a << " " << std::endl;
|
||||||
assert(abs(tr) < 1.0e-6);
|
assert(abs(tr) < 1.0e-6);
|
||||||
}
|
}
|
||||||
std::cout << GridLogMessage << std::endl;
|
std::cout << GridLogMessage << std::endl;
|
||||||
|
|
||||||
|
AMatrix adjTa;
|
||||||
|
std::cout << GridLogMessage << "Adjoint - Checking if real" << std::endl;
|
||||||
|
for (int a = 0; a < generators(); a++) {
|
||||||
|
generatorAdjoint(a, adjTa);
|
||||||
|
std::cout << GridLogMessage << a << std::endl;
|
||||||
|
assert(norm2(adjTa - conjugate(adjTa)) < 1.0e-6);
|
||||||
|
}
|
||||||
|
std::cout << GridLogMessage << std::endl;
|
||||||
|
|
||||||
|
std::cout << GridLogMessage << "Adjoint - Checking if antisymmetric" << std::endl;
|
||||||
|
for (int a = 0; a < generators(); a++) {
|
||||||
|
generatorAdjoint(a, adjTa);
|
||||||
|
std::cout << GridLogMessage << a << std::endl;
|
||||||
|
assert(norm2(adjTa + transpose(adjTa)) < 1.0e-6);
|
||||||
|
}
|
||||||
|
std::cout << GridLogMessage << std::endl;
|
||||||
|
|
||||||
|
|
||||||
|
|
||||||
|
|
||||||
}
|
}
|
||||||
|
|
||||||
// reunitarise??
|
// reunitarise??
|
||||||
template <typename LatticeMatrixType>
|
template <typename LatticeMatrixType>
|
||||||
static void LieRandomize(GridParallelRNG &pRNG,LatticeMatrixType &out,double scale=1.0){
|
static void LieRandomize(GridParallelRNG &pRNG, LatticeMatrixType &out,
|
||||||
|
double scale = 1.0) {
|
||||||
GridBase *grid = out._grid;
|
GridBase *grid = out._grid;
|
||||||
|
|
||||||
typedef typename LatticeMatrixType::vector_type vector_type;
|
typedef typename LatticeMatrixType::vector_type vector_type;
|
||||||
@ -562,7 +669,8 @@ Note that in step D setting B ~ X - A and using B in place of A in step E will g
|
|||||||
typedef iSinglet<vector_type> vTComplexType;
|
typedef iSinglet<vector_type> vTComplexType;
|
||||||
|
|
||||||
typedef Lattice<vTComplexType> LatticeComplexType;
|
typedef Lattice<vTComplexType> LatticeComplexType;
|
||||||
typedef typename GridTypeMapper<typename LatticeMatrixType::vector_object>::scalar_object MatrixType;
|
typedef typename GridTypeMapper<
|
||||||
|
typename LatticeMatrixType::vector_object>::scalar_object MatrixType;
|
||||||
|
|
||||||
LatticeComplexType ca(grid);
|
LatticeComplexType ca(grid);
|
||||||
LatticeMatrixType lie(grid);
|
LatticeMatrixType lie(grid);
|
||||||
@ -573,7 +681,6 @@ Note that in step D setting B ~ X - A and using B in place of A in step E will g
|
|||||||
|
|
||||||
lie = zero;
|
lie = zero;
|
||||||
for (int a = 0; a < generators(); a++) {
|
for (int a = 0; a < generators(); a++) {
|
||||||
|
|
||||||
random(pRNG, ca);
|
random(pRNG, ca);
|
||||||
|
|
||||||
ca = (ca + conjugate(ca)) * 0.5;
|
ca = (ca + conjugate(ca)) * 0.5;
|
||||||
@ -588,7 +695,9 @@ Note that in step D setting B ~ X - A and using B in place of A in step E will g
|
|||||||
taExp(lie, out);
|
taExp(lie, out);
|
||||||
}
|
}
|
||||||
|
|
||||||
static void GaussianLieAlgebraMatrix(GridParallelRNG &pRNG,LatticeMatrix &out,double scale=1.0){
|
static void GaussianFundamentalLieAlgebraMatrix(GridParallelRNG &pRNG,
|
||||||
|
LatticeMatrix &out,
|
||||||
|
Real scale = 1.0) {
|
||||||
GridBase *grid = out._grid;
|
GridBase *grid = out._grid;
|
||||||
LatticeReal ca(grid);
|
LatticeReal ca(grid);
|
||||||
LatticeMatrix la(grid);
|
LatticeMatrix la(grid);
|
||||||
@ -602,7 +711,20 @@ Note that in step D setting B ~ X - A and using B in place of A in step E will g
|
|||||||
la = toComplex(ca) * ci * ta;
|
la = toComplex(ca) * ci * ta;
|
||||||
out += la;
|
out += la;
|
||||||
}
|
}
|
||||||
|
}
|
||||||
|
|
||||||
|
static void FundamentalLieAlgebraMatrix(Vector<Real> &h, LatticeMatrix &out,
|
||||||
|
Real scale = 1.0) {
|
||||||
|
GridBase *grid = out._grid;
|
||||||
|
LatticeMatrix la(grid);
|
||||||
|
Matrix ta;
|
||||||
|
|
||||||
|
out = zero;
|
||||||
|
for (int a = 0; a < generators(); a++) {
|
||||||
|
generator(a, ta);
|
||||||
|
la = Complex(0.0, h[a]) * scale * ta;
|
||||||
|
out += la;
|
||||||
|
}
|
||||||
}
|
}
|
||||||
|
|
||||||
template <typename GaugeField>
|
template <typename GaugeField>
|
||||||
@ -617,7 +739,8 @@ Note that in step D setting B ~ X - A and using B in place of A in step E will g
|
|||||||
PokeIndex<LorentzIndex>(out, Umu, mu);
|
PokeIndex<LorentzIndex>(out, Umu, mu);
|
||||||
}
|
}
|
||||||
}
|
}
|
||||||
static void TepidConfiguration(GridParallelRNG &pRNG,LatticeGaugeField &out){
|
static void TepidConfiguration(GridParallelRNG &pRNG,
|
||||||
|
LatticeGaugeField &out) {
|
||||||
LatticeMatrix Umu(out._grid);
|
LatticeMatrix Umu(out._grid);
|
||||||
for (int mu = 0; mu < Nd; mu++) {
|
for (int mu = 0; mu < Nd; mu++) {
|
||||||
LieRandomize(pRNG, Umu, 0.01);
|
LieRandomize(pRNG, Umu, 0.01);
|
||||||
@ -646,21 +769,18 @@ Note that in step D setting B ~ X - A and using B in place of A in step E will g
|
|||||||
ex = xn + ComplexType(1.0); // 1+x
|
ex = xn + ComplexType(1.0); // 1+x
|
||||||
|
|
||||||
// Do a 12th order exponentiation
|
// Do a 12th order exponentiation
|
||||||
for(int i=2; i <= 12; ++i)
|
for (int i = 2; i <= 12; ++i) {
|
||||||
{
|
|
||||||
nfac = nfac / RealD(i); // 1/2, 1/2.3 ...
|
nfac = nfac / RealD(i); // 1/2, 1/2.3 ...
|
||||||
xn = xn * x; // x2, x3,x4....
|
xn = xn * x; // x2, x3,x4....
|
||||||
ex = ex + xn * nfac; // x2/2!, x3/3!....
|
ex = ex + xn * nfac; // x2/2!, x3/3!....
|
||||||
}
|
}
|
||||||
}
|
}
|
||||||
|
|
||||||
};
|
};
|
||||||
|
|
||||||
typedef SU<2> SU2;
|
typedef SU<2> SU2;
|
||||||
typedef SU<3> SU3;
|
typedef SU<3> SU3;
|
||||||
typedef SU<4> SU4;
|
typedef SU<4> SU4;
|
||||||
typedef SU<5> SU5;
|
typedef SU<5> SU5;
|
||||||
|
|
||||||
}
|
}
|
||||||
}
|
}
|
||||||
#endif
|
#endif
|
||||||
|
@ -96,7 +96,7 @@ int main (int argc, char ** argv)
|
|||||||
|
|
||||||
for(int mu=0;mu<Nd;mu++){
|
for(int mu=0;mu<Nd;mu++){
|
||||||
|
|
||||||
SU3::GaussianLieAlgebraMatrix(RNG4, mommu); // Traceless antihermitian momentum; gaussian in lie alg
|
SU3::GaussianFundamentalLieAlgebraMatrix(RNG4, mommu); // Traceless antihermitian momentum; gaussian in lie alg
|
||||||
|
|
||||||
PokeIndex<LorentzIndex>(mom,mommu,mu);
|
PokeIndex<LorentzIndex>(mom,mommu,mu);
|
||||||
|
|
||||||
|
@ -96,7 +96,7 @@ int main (int argc, char ** argv)
|
|||||||
|
|
||||||
for(int mu=0;mu<Nd;mu++){
|
for(int mu=0;mu<Nd;mu++){
|
||||||
|
|
||||||
SU3::GaussianLieAlgebraMatrix(RNG4, mommu); // Traceless antihermitian momentum; gaussian in lie alg
|
SU3::GaussianFundamentalLieAlgebraMatrix(RNG4, mommu); // Traceless antihermitian momentum; gaussian in lie alg
|
||||||
|
|
||||||
PokeIndex<LorentzIndex>(mom,mommu,mu);
|
PokeIndex<LorentzIndex>(mom,mommu,mu);
|
||||||
|
|
||||||
|
@ -113,7 +113,7 @@ int main (int argc, char ** argv)
|
|||||||
|
|
||||||
for(int mu=0;mu<Nd;mu++){
|
for(int mu=0;mu<Nd;mu++){
|
||||||
|
|
||||||
SU3::GaussianLieAlgebraMatrix(RNG4, mommu); // Traceless antihermitian momentum; gaussian in lie alg
|
SU3::GaussianFundamentalLieAlgebraMatrix(RNG4, mommu); // Traceless antihermitian momentum; gaussian in lie alg
|
||||||
|
|
||||||
Hmom -= real(sum(trace(mommu*mommu)));
|
Hmom -= real(sum(trace(mommu*mommu)));
|
||||||
|
|
||||||
|
@ -82,7 +82,7 @@ int main (int argc, char ** argv)
|
|||||||
|
|
||||||
for(int mu=0;mu<Nd;mu++){
|
for(int mu=0;mu<Nd;mu++){
|
||||||
|
|
||||||
SU3::GaussianLieAlgebraMatrix(pRNG, mommu); // Traceless antihermitian momentum; gaussian in lie alg
|
SU3::GaussianFundamentalLieAlgebraMatrix(pRNG, mommu); // Traceless antihermitian momentum; gaussian in lie alg
|
||||||
|
|
||||||
PokeIndex<LorentzIndex>(mom,mommu,mu);
|
PokeIndex<LorentzIndex>(mom,mommu,mu);
|
||||||
|
|
||||||
|
@ -100,7 +100,7 @@ int main (int argc, char ** argv)
|
|||||||
|
|
||||||
for(int mu=0;mu<Nd;mu++){
|
for(int mu=0;mu<Nd;mu++){
|
||||||
|
|
||||||
SU3::GaussianLieAlgebraMatrix(RNG4, mommu); // Traceless antihermitian momentum; gaussian in lie alg
|
SU3::GaussianFundamentalLieAlgebraMatrix(RNG4, mommu); // Traceless antihermitian momentum; gaussian in lie alg
|
||||||
|
|
||||||
PokeIndex<LorentzIndex>(mom,mommu,mu);
|
PokeIndex<LorentzIndex>(mom,mommu,mu);
|
||||||
|
|
||||||
@ -169,7 +169,7 @@ int main (int argc, char ** argv)
|
|||||||
//
|
//
|
||||||
// Pmu = zero;
|
// Pmu = zero;
|
||||||
// for(int mu=0;mu<Nd;mu++){
|
// for(int mu=0;mu<Nd;mu++){
|
||||||
// SU<Ncol>::GaussianLieAlgebraMatrix(pRNG, Pmu);
|
// SU<Ncol>::GaussianFundamentalLieAlgebraMatrix(pRNG, Pmu);
|
||||||
// PokeIndex<LorentzIndex>(P, Pmu, mu);
|
// PokeIndex<LorentzIndex>(P, Pmu, mu);
|
||||||
// }
|
// }
|
||||||
//
|
//
|
||||||
|
@ -23,48 +23,52 @@ Author: Peter Boyle <paboyle@ph.ed.ac.uk>
|
|||||||
with this program; if not, write to the Free Software Foundation, Inc.,
|
with this program; if not, write to the Free Software Foundation, Inc.,
|
||||||
51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA.
|
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 */
|
/* END LEGAL */
|
||||||
#include <Grid.h>
|
#include <Grid.h>
|
||||||
|
|
||||||
#include <qcd/utils/CovariantCshift.h>
|
#include <qcd/utils/CovariantCshift.h>
|
||||||
#include <qcd/utils/WilsonLoops.h>
|
|
||||||
#include <qcd/utils/SUn.h>
|
#include <qcd/utils/SUn.h>
|
||||||
|
#include <qcd/utils/WilsonLoops.h>
|
||||||
|
|
||||||
using namespace std;
|
using namespace std;
|
||||||
using namespace Grid;
|
using namespace Grid;
|
||||||
using namespace Grid::QCD;
|
using namespace Grid::QCD;
|
||||||
|
|
||||||
|
int main(int argc, char** argv) {
|
||||||
int main (int argc, char ** argv)
|
|
||||||
{
|
|
||||||
Grid_init(&argc, &argv);
|
Grid_init(&argc, &argv);
|
||||||
|
|
||||||
std::vector<int> latt({4, 4, 4, 8});
|
std::vector<int> latt({4, 4, 4, 8});
|
||||||
GridCartesian * grid = SpaceTimeGrid::makeFourDimGrid(latt,
|
GridCartesian* grid = SpaceTimeGrid::makeFourDimGrid(
|
||||||
GridDefaultSimd(Nd,vComplex::Nsimd()),
|
latt, GridDefaultSimd(Nd, vComplex::Nsimd()), GridDefaultMpi());
|
||||||
GridDefaultMpi());
|
|
||||||
|
|
||||||
GridRedBlackCartesian* rbGrid = SpaceTimeGrid::makeFourDimRedBlackGrid(grid);
|
GridRedBlackCartesian* rbGrid = SpaceTimeGrid::makeFourDimRedBlackGrid(grid);
|
||||||
|
|
||||||
std::cout<<GridLogMessage<<"*********************************************"<<std::endl;
|
std::cout << GridLogMessage << "*********************************************"
|
||||||
|
<< std::endl;
|
||||||
std::cout << GridLogMessage << "* Generators for SU(2)" << std::endl;
|
std::cout << GridLogMessage << "* Generators for SU(2)" << std::endl;
|
||||||
std::cout<<GridLogMessage<<"*********************************************"<<std::endl;
|
std::cout << GridLogMessage << "*********************************************"
|
||||||
|
<< std::endl;
|
||||||
SU2::printGenerators();
|
SU2::printGenerators();
|
||||||
|
SU2::printAdjointGenerators();
|
||||||
SU2::testGenerators();
|
SU2::testGenerators();
|
||||||
|
|
||||||
std::cout<<GridLogMessage<<"*********************************************"<<std::endl;
|
std::cout << GridLogMessage << "*********************************************"
|
||||||
|
<< std::endl;
|
||||||
std::cout << GridLogMessage << "* Generators for SU(3)" << std::endl;
|
std::cout << GridLogMessage << "* Generators for SU(3)" << std::endl;
|
||||||
std::cout<<GridLogMessage<<"*********************************************"<<std::endl;
|
std::cout << GridLogMessage << "*********************************************"
|
||||||
|
<< std::endl;
|
||||||
SU3::printGenerators();
|
SU3::printGenerators();
|
||||||
|
SU3::printAdjointGenerators();
|
||||||
SU3::testGenerators();
|
SU3::testGenerators();
|
||||||
|
|
||||||
// std::cout<<GridLogMessage<<"*********************************************"<<std::endl;
|
std::cout<<GridLogMessage<<"*********************************************"<<std::endl;
|
||||||
// std::cout<<GridLogMessage<<"* Generators for SU(4)"<<std::endl;
|
std::cout<<GridLogMessage<<"* Generators for SU(4)"<<std::endl;
|
||||||
// std::cout<<GridLogMessage<<"*********************************************"<<std::endl;
|
std::cout<<GridLogMessage<<"*********************************************"<<std::endl;
|
||||||
// SU4::printGenerators();
|
SU4::printGenerators();
|
||||||
// SU4::testGenerators();
|
SU4::testGenerators();
|
||||||
|
|
||||||
// std::cout<<GridLogMessage<<"*********************************************"<<std::endl;
|
// std::cout<<GridLogMessage<<"*********************************************"<<std::endl;
|
||||||
// std::cout<<GridLogMessage<<"* Generators for SU(5)"<<std::endl;
|
// std::cout<<GridLogMessage<<"* Generators for SU(5)"<<std::endl;
|
||||||
@ -72,8 +76,5 @@ int main (int argc, char ** argv)
|
|||||||
// SU5::printGenerators();
|
// SU5::printGenerators();
|
||||||
// SU5::testGenerators();
|
// SU5::testGenerators();
|
||||||
|
|
||||||
|
|
||||||
Grid_finalize();
|
Grid_finalize();
|
||||||
}
|
}
|
||||||
|
|
||||||
|
|
||||||
|
@ -96,7 +96,7 @@ int main (int argc, char ** argv)
|
|||||||
|
|
||||||
for(int mu=0;mu<Nd;mu++){
|
for(int mu=0;mu<Nd;mu++){
|
||||||
|
|
||||||
SU3::GaussianLieAlgebraMatrix(RNG4, mommu); // Traceless antihermitian momentum; gaussian in lie alg
|
SU3::GaussianFundamentalLieAlgebraMatrix(RNG4, mommu); // Traceless antihermitian momentum; gaussian in lie alg
|
||||||
|
|
||||||
PokeIndex<LorentzIndex>(mom,mommu,mu);
|
PokeIndex<LorentzIndex>(mom,mommu,mu);
|
||||||
|
|
||||||
|
@ -81,7 +81,7 @@ int main (int argc, char ** argv)
|
|||||||
|
|
||||||
for(int mu=0;mu<Nd;mu++){
|
for(int mu=0;mu<Nd;mu++){
|
||||||
|
|
||||||
SU3::GaussianLieAlgebraMatrix(pRNG, mommu); // Traceless antihermitian momentum; gaussian in lie alg
|
SU3::GaussianFundamentalLieAlgebraMatrix(pRNG, mommu); // Traceless antihermitian momentum; gaussian in lie alg
|
||||||
|
|
||||||
PokeIndex<LorentzIndex>(mom,mommu,mu);
|
PokeIndex<LorentzIndex>(mom,mommu,mu);
|
||||||
|
|
||||||
|
@ -93,7 +93,7 @@ int main (int argc, char ** argv)
|
|||||||
|
|
||||||
for(int mu=0;mu<Nd;mu++){
|
for(int mu=0;mu<Nd;mu++){
|
||||||
|
|
||||||
SU3::GaussianLieAlgebraMatrix(pRNG, mommu); // Traceless antihermitian momentum; gaussian in lie alg
|
SU3::GaussianFundamentalLieAlgebraMatrix(pRNG, mommu); // Traceless antihermitian momentum; gaussian in lie alg
|
||||||
|
|
||||||
Hmom -= real(sum(trace(mommu*mommu)));
|
Hmom -= real(sum(trace(mommu*mommu)));
|
||||||
|
|
||||||
|
@ -103,7 +103,7 @@ int main (int argc, char ** argv)
|
|||||||
|
|
||||||
for(int mu=0;mu<Nd;mu++){
|
for(int mu=0;mu<Nd;mu++){
|
||||||
|
|
||||||
SU3::GaussianLieAlgebraMatrix(pRNG, mommu); // Traceless antihermitian momentum; gaussian in lie alg
|
SU3::GaussianFundamentalLieAlgebraMatrix(pRNG, mommu); // Traceless antihermitian momentum; gaussian in lie alg
|
||||||
|
|
||||||
// Dw.DoubleStore(Dw.Umu,Uprime); // update U _and_ Udag
|
// Dw.DoubleStore(Dw.Umu,Uprime); // update U _and_ Udag
|
||||||
Dw.DhopDirDisp(phi,Ftmp,mu,mu+4,DaggerYes);
|
Dw.DhopDirDisp(phi,Ftmp,mu,mu+4,DaggerYes);
|
||||||
|
@ -86,7 +86,7 @@ int main (int argc, char ** argv)
|
|||||||
LatticeColourMatrix Umu_save(&Grid);
|
LatticeColourMatrix Umu_save(&Grid);
|
||||||
LatticeColourMatrix dU (&Grid);
|
LatticeColourMatrix dU (&Grid);
|
||||||
LatticeColourMatrix mom(&Grid);
|
LatticeColourMatrix mom(&Grid);
|
||||||
SU3::GaussianLieAlgebraMatrix(pRNG, mom); // Traceless antihermitian momentum; gaussian in lie alg
|
SU3::GaussianFundamentalLieAlgebraMatrix(pRNG, mom); // Traceless antihermitian momentum; gaussian in lie alg
|
||||||
|
|
||||||
|
|
||||||
// check mom is as i expect
|
// check mom is as i expect
|
||||||
|
Loading…
x
Reference in New Issue
Block a user