mirror of
https://github.com/paboyle/Grid.git
synced 2024-11-10 07:55:35 +00:00
Merge branch 'develop' into feature/distil
* develop: (29 commits) precision fix Updates after review with Peter. Wilson clover multi grid for lime lattice Recommendations for Traits classes Hadrons: uninitialised pointer fix (might have been harmless) Hadrons: beware of the nasty uninitialised twists Smearing test. Test on free field. Smearing for quark observables Smearing Hadrons: XML validator utility display relative norm during field IO norm check possibility to set a build number IO norm check on relative norm Output field norm check during IO Hadrons: random vector utility module I/O quieter initialisation fix patch command for eigen in bootstrap.sh Mres changes and gauge xform mat changes Hadrons: 32 bit I/O directly in Lanczos module Hadrons: copyright update ... # Conflicts: # Grid/tensors/Tensor_traits.h # Hadrons/Modules.hpp # Hadrons/modules.inc
This commit is contained in:
commit
11dded61e8
@ -42,6 +42,7 @@ Author: paboyle <paboyle@ph.ed.ac.uk>
|
|||||||
#include <Grid/GridQCDcore.h>
|
#include <Grid/GridQCDcore.h>
|
||||||
#include <Grid/qcd/action/Action.h>
|
#include <Grid/qcd/action/Action.h>
|
||||||
#include <Grid/qcd/utils/GaugeFix.h>
|
#include <Grid/qcd/utils/GaugeFix.h>
|
||||||
|
#include <Grid/qcd/utils/CovariantSmearing.h>
|
||||||
#include <Grid/qcd/smearing/Smearing.h>
|
#include <Grid/qcd/smearing/Smearing.h>
|
||||||
#include <Grid/parallelIO/MetaData.h>
|
#include <Grid/parallelIO/MetaData.h>
|
||||||
#include <Grid/qcd/hmc/HMC_aggregate.h>
|
#include <Grid/qcd/hmc/HMC_aggregate.h>
|
||||||
|
@ -53,10 +53,12 @@ void CartesianCommunicator::Init(int *argc, char ***argv)
|
|||||||
// Never clean up as done once.
|
// Never clean up as done once.
|
||||||
MPI_Comm_dup (MPI_COMM_WORLD,&communicator_world);
|
MPI_Comm_dup (MPI_COMM_WORLD,&communicator_world);
|
||||||
|
|
||||||
|
Grid_quiesce_nodes();
|
||||||
GlobalSharedMemory::Init(communicator_world);
|
GlobalSharedMemory::Init(communicator_world);
|
||||||
GlobalSharedMemory::SharedMemoryAllocate(
|
GlobalSharedMemory::SharedMemoryAllocate(
|
||||||
GlobalSharedMemory::MAX_MPI_SHM_BYTES,
|
GlobalSharedMemory::MAX_MPI_SHM_BYTES,
|
||||||
GlobalSharedMemory::Hugepages);
|
GlobalSharedMemory::Hugepages);
|
||||||
|
Grid_unquiesce_nodes();
|
||||||
}
|
}
|
||||||
|
|
||||||
///////////////////////////////////////////////////////////////////////////
|
///////////////////////////////////////////////////////////////////////////
|
||||||
|
@ -47,7 +47,10 @@ namespace Grid {
|
|||||||
namespace QCD {
|
namespace QCD {
|
||||||
|
|
||||||
#define GRID_FIELD_NORM "FieldNormMetaData"
|
#define GRID_FIELD_NORM "FieldNormMetaData"
|
||||||
#define GRID_FIELD_NORM_CHECK(FieldNormMetaData_,n2ck) assert(fabs(FieldNormMetaData_.norm2 - n2ck < 1.0e-5 ));
|
#define GRID_FIELD_NORM_CALC(FieldNormMetaData_, n2ck) \
|
||||||
|
0.5*fabs(FieldNormMetaData_.norm2 - n2ck)/(FieldNormMetaData_.norm2 + n2ck)
|
||||||
|
#define GRID_FIELD_NORM_CHECK(FieldNormMetaData_, n2ck) \
|
||||||
|
assert(GRID_FIELD_NORM_CALC(FieldNormMetaData_, n2ck) < 1.0e-5);
|
||||||
|
|
||||||
/////////////////////////////////
|
/////////////////////////////////
|
||||||
// Encode word types as strings
|
// Encode word types as strings
|
||||||
@ -248,9 +251,9 @@ class GridLimeReader : public BinaryIO {
|
|||||||
/////////////////////////////////////////////
|
/////////////////////////////////////////////
|
||||||
if(FieldNormMetaData_.norm2 != 0.0){
|
if(FieldNormMetaData_.norm2 != 0.0){
|
||||||
RealD n2ck = norm2(field);
|
RealD n2ck = norm2(field);
|
||||||
// std::cout << GridLogMessage << "checking field norm: metadata "<<FieldNormMetaData_.norm2<< " vs " << n2ck<<std::endl;
|
std::cout << GridLogMessage << "Field norm: metadata= " << FieldNormMetaData_.norm2
|
||||||
|
<< " / field= " << n2ck << " / rdiff= " << GRID_FIELD_NORM_CALC(FieldNormMetaData_,n2ck) << std::endl;
|
||||||
GRID_FIELD_NORM_CHECK(FieldNormMetaData_,n2ck);
|
GRID_FIELD_NORM_CHECK(FieldNormMetaData_,n2ck);
|
||||||
std::cout << GridLogMessage << "FieldNormMetaData OK! "<<std::endl;
|
|
||||||
}
|
}
|
||||||
assert(scidacChecksumVerify(scidacChecksum_,scidac_csuma,scidac_csumb)==1);
|
assert(scidacChecksumVerify(scidacChecksum_,scidac_csuma,scidac_csumb)==1);
|
||||||
|
|
||||||
|
@ -113,7 +113,7 @@ namespace Grid {
|
|||||||
LatticeCoordinate(coor, nu);
|
LatticeCoordinate(coor, nu);
|
||||||
ph = ph + twist[nu]*coor*((1./(in._grid->_fdimensions[nu])));
|
ph = ph + twist[nu]*coor*((1./(in._grid->_fdimensions[nu])));
|
||||||
}
|
}
|
||||||
in_buf = exp((Real)(2.0*M_PI)*ci*ph*(-1.0))*in;
|
in_buf = exp((Real)(-2.0*M_PI)*ci*ph)*in;
|
||||||
|
|
||||||
theFFT.FFT_all_dim(in_k,in_buf,FFT::forward);
|
theFFT.FFT_all_dim(in_k,in_buf,FFT::forward);
|
||||||
this->MomentumSpacePropagator(prop_k,in_k,mass,twist);
|
this->MomentumSpacePropagator(prop_k,in_k,mass,twist);
|
||||||
@ -136,6 +136,7 @@ namespace Grid {
|
|||||||
//////////////////////////////////////////////////////////////////////
|
//////////////////////////////////////////////////////////////////////
|
||||||
// Conserved currents, either contract at sink or insert sequentially.
|
// Conserved currents, either contract at sink or insert sequentially.
|
||||||
//////////////////////////////////////////////////////////////////////
|
//////////////////////////////////////////////////////////////////////
|
||||||
|
|
||||||
virtual void ContractConservedCurrent(PropagatorField &q_in_1,
|
virtual void ContractConservedCurrent(PropagatorField &q_in_1,
|
||||||
PropagatorField &q_in_2,
|
PropagatorField &q_in_2,
|
||||||
PropagatorField &q_out,
|
PropagatorField &q_out,
|
||||||
@ -148,6 +149,12 @@ namespace Grid {
|
|||||||
unsigned int tmin,
|
unsigned int tmin,
|
||||||
unsigned int tmax,
|
unsigned int tmax,
|
||||||
ComplexField &lattice_cmplx)=0;
|
ComplexField &lattice_cmplx)=0;
|
||||||
|
|
||||||
|
// Only reimplemented in Wilson5D
|
||||||
|
// Default to just a zero correlation function
|
||||||
|
virtual void ContractJ5q(FermionField &q_in ,ComplexField &J5q) { J5q=zero; };
|
||||||
|
virtual void ContractJ5q(PropagatorField &q_in,ComplexField &J5q) { J5q=zero; };
|
||||||
|
|
||||||
///////////////////////////////////////////////
|
///////////////////////////////////////////////
|
||||||
// Physical field import/export
|
// Physical field import/export
|
||||||
///////////////////////////////////////////////
|
///////////////////////////////////////////////
|
||||||
|
@ -939,6 +939,75 @@ void WilsonFermion5D<Impl>::MomentumSpacePropagatorHw(FermionField &out,const Fe
|
|||||||
merge(qSiteRev, qSiteVec); \
|
merge(qSiteRev, qSiteVec); \
|
||||||
}
|
}
|
||||||
|
|
||||||
|
// psi = chiralProjectPlus(Result_s[Ls/2-1]);
|
||||||
|
// psi+= chiralProjectMinus(Result_s[Ls/2]);
|
||||||
|
// PJ5q+=localInnerProduct(psi,psi);
|
||||||
|
|
||||||
|
template<class vobj>
|
||||||
|
Lattice<vobj> spProj5p(const Lattice<vobj> & in)
|
||||||
|
{
|
||||||
|
GridBase *grid=in._grid;
|
||||||
|
Gamma G5(Gamma::Algebra::Gamma5);
|
||||||
|
Lattice<vobj> ret(grid);
|
||||||
|
parallel_for(int ss=0;ss<grid->oSites();ss++){
|
||||||
|
ret._odata[ss] = in._odata[ss] + G5*in._odata[ss];
|
||||||
|
}
|
||||||
|
return ret;
|
||||||
|
}
|
||||||
|
template<class vobj>
|
||||||
|
Lattice<vobj> spProj5m(const Lattice<vobj> & in)
|
||||||
|
{
|
||||||
|
Gamma G5(Gamma::Algebra::Gamma5);
|
||||||
|
GridBase *grid=in._grid;
|
||||||
|
Lattice<vobj> ret(grid);
|
||||||
|
parallel_for(int ss=0;ss<grid->oSites();ss++){
|
||||||
|
ret._odata[ss] = in._odata[ss] - G5*in._odata[ss];
|
||||||
|
}
|
||||||
|
return ret;
|
||||||
|
}
|
||||||
|
|
||||||
|
template <class Impl>
|
||||||
|
void WilsonFermion5D<Impl>::ContractJ5q(FermionField &q_in,ComplexField &J5q)
|
||||||
|
{
|
||||||
|
conformable(GaugeGrid(), J5q._grid);
|
||||||
|
conformable(q_in._grid, FermionGrid());
|
||||||
|
|
||||||
|
// 4d field
|
||||||
|
int Ls = this->Ls;
|
||||||
|
FermionField psi(GaugeGrid());
|
||||||
|
FermionField p_plus (GaugeGrid());
|
||||||
|
FermionField p_minus(GaugeGrid());
|
||||||
|
FermionField p(GaugeGrid());
|
||||||
|
|
||||||
|
ExtractSlice(p_plus , q_in, Ls/2 , 0);
|
||||||
|
ExtractSlice(p_minus, q_in, Ls/2-1 , 0);
|
||||||
|
p_plus = spProj5p(p_plus );
|
||||||
|
p_minus= spProj5m(p_minus);
|
||||||
|
p=p_plus+p_minus;
|
||||||
|
J5q = localInnerProduct(p,p);
|
||||||
|
}
|
||||||
|
|
||||||
|
template <class Impl>
|
||||||
|
void WilsonFermion5D<Impl>::ContractJ5q(PropagatorField &q_in,ComplexField &J5q)
|
||||||
|
{
|
||||||
|
conformable(GaugeGrid(), J5q._grid);
|
||||||
|
conformable(q_in._grid, FermionGrid());
|
||||||
|
|
||||||
|
// 4d field
|
||||||
|
int Ls = this->Ls;
|
||||||
|
PropagatorField psi(GaugeGrid());
|
||||||
|
PropagatorField p_plus (GaugeGrid());
|
||||||
|
PropagatorField p_minus(GaugeGrid());
|
||||||
|
PropagatorField p(GaugeGrid());
|
||||||
|
|
||||||
|
ExtractSlice(p_plus , q_in, Ls/2 , 0);
|
||||||
|
ExtractSlice(p_minus, q_in, Ls/2-1 , 0);
|
||||||
|
p_plus = spProj5p(p_plus );
|
||||||
|
p_minus= spProj5m(p_minus);
|
||||||
|
p=p_plus+p_minus;
|
||||||
|
J5q = localInnerProduct(p,p);
|
||||||
|
}
|
||||||
|
|
||||||
template <class Impl>
|
template <class Impl>
|
||||||
void WilsonFermion5D<Impl>::ContractConservedCurrent(PropagatorField &q_in_1,
|
void WilsonFermion5D<Impl>::ContractConservedCurrent(PropagatorField &q_in_1,
|
||||||
PropagatorField &q_in_2,
|
PropagatorField &q_in_2,
|
||||||
@ -949,6 +1018,7 @@ void WilsonFermion5D<Impl>::ContractConservedCurrent(PropagatorField &q_in_1,
|
|||||||
conformable(q_in_1._grid, FermionGrid());
|
conformable(q_in_1._grid, FermionGrid());
|
||||||
conformable(q_in_1._grid, q_in_2._grid);
|
conformable(q_in_1._grid, q_in_2._grid);
|
||||||
conformable(_FourDimGrid, q_out._grid);
|
conformable(_FourDimGrid, q_out._grid);
|
||||||
|
|
||||||
PropagatorField tmp1(FermionGrid()), tmp2(FermionGrid());
|
PropagatorField tmp1(FermionGrid()), tmp2(FermionGrid());
|
||||||
unsigned int LLs = q_in_1._grid->_rdimensions[0];
|
unsigned int LLs = q_in_1._grid->_rdimensions[0];
|
||||||
q_out = zero;
|
q_out = zero;
|
||||||
@ -995,7 +1065,6 @@ void WilsonFermion5D<Impl>::ContractConservedCurrent(PropagatorField &q_in_1,
|
|||||||
}
|
}
|
||||||
|
|
||||||
|
|
||||||
|
|
||||||
template <class Impl>
|
template <class Impl>
|
||||||
void WilsonFermion5D<Impl>::SeqConservedCurrent(PropagatorField &q_in,
|
void WilsonFermion5D<Impl>::SeqConservedCurrent(PropagatorField &q_in,
|
||||||
PropagatorField &q_out,
|
PropagatorField &q_out,
|
||||||
|
@ -230,6 +230,10 @@ namespace QCD {
|
|||||||
unsigned int tmin,
|
unsigned int tmin,
|
||||||
unsigned int tmax,
|
unsigned int tmax,
|
||||||
ComplexField &lattice_cmplx);
|
ComplexField &lattice_cmplx);
|
||||||
|
|
||||||
|
void ContractJ5q(PropagatorField &q_in,ComplexField &J5q);
|
||||||
|
void ContractJ5q(FermionField &q_in,ComplexField &J5q);
|
||||||
|
|
||||||
};
|
};
|
||||||
|
|
||||||
}}
|
}}
|
||||||
|
@ -11,6 +11,24 @@ const std::array<const Gamma, 4> Gamma::gmu = {{
|
|||||||
Gamma(Gamma::Algebra::GammaZ),
|
Gamma(Gamma::Algebra::GammaZ),
|
||||||
Gamma(Gamma::Algebra::GammaT)}};
|
Gamma(Gamma::Algebra::GammaT)}};
|
||||||
|
|
||||||
|
const std::array<const Gamma, 16> Gamma::gall = {{
|
||||||
|
Gamma(Gamma::Algebra::Identity),
|
||||||
|
Gamma(Gamma::Algebra::Gamma5),
|
||||||
|
Gamma(Gamma::Algebra::GammaX),
|
||||||
|
Gamma(Gamma::Algebra::GammaY),
|
||||||
|
Gamma(Gamma::Algebra::GammaZ),
|
||||||
|
Gamma(Gamma::Algebra::GammaT),
|
||||||
|
Gamma(Gamma::Algebra::GammaXGamma5),
|
||||||
|
Gamma(Gamma::Algebra::GammaYGamma5),
|
||||||
|
Gamma(Gamma::Algebra::GammaZGamma5),
|
||||||
|
Gamma(Gamma::Algebra::GammaTGamma5),
|
||||||
|
Gamma(Gamma::Algebra::SigmaXT),
|
||||||
|
Gamma(Gamma::Algebra::SigmaXY),
|
||||||
|
Gamma(Gamma::Algebra::SigmaXZ),
|
||||||
|
Gamma(Gamma::Algebra::SigmaYT),
|
||||||
|
Gamma(Gamma::Algebra::SigmaYZ),
|
||||||
|
Gamma(Gamma::Algebra::SigmaZT)}};
|
||||||
|
|
||||||
const std::array<const char *, Gamma::nGamma> Gamma::name = {{
|
const std::array<const char *, Gamma::nGamma> Gamma::name = {{
|
||||||
"-Gamma5 ",
|
"-Gamma5 ",
|
||||||
"Gamma5 ",
|
"Gamma5 ",
|
||||||
|
@ -48,6 +48,7 @@ class Gamma {
|
|||||||
static const std::array<std::array<Algebra, nGamma>, nGamma> mul;
|
static const std::array<std::array<Algebra, nGamma>, nGamma> mul;
|
||||||
static const std::array<Algebra, nGamma> adj;
|
static const std::array<Algebra, nGamma> adj;
|
||||||
static const std::array<const Gamma, 4> gmu;
|
static const std::array<const Gamma, 4> gmu;
|
||||||
|
static const std::array<const Gamma, 16> gall;
|
||||||
Algebra g;
|
Algebra g;
|
||||||
public:
|
public:
|
||||||
Gamma(Algebra initg): g(initg) {}
|
Gamma(Algebra initg): g(initg) {}
|
||||||
|
@ -10,10 +10,10 @@
|
|||||||
NotebookFileLineBreakTest
|
NotebookFileLineBreakTest
|
||||||
NotebookFileLineBreakTest
|
NotebookFileLineBreakTest
|
||||||
NotebookDataPosition[ 158, 7]
|
NotebookDataPosition[ 158, 7]
|
||||||
NotebookDataLength[ 75090, 1956]
|
NotebookDataLength[ 67118, 1714]
|
||||||
NotebookOptionsPosition[ 69536, 1867]
|
NotebookOptionsPosition[ 63485, 1652]
|
||||||
NotebookOutlinePosition[ 69898, 1883]
|
NotebookOutlinePosition[ 63842, 1668]
|
||||||
CellTagsIndexPosition[ 69855, 1880]
|
CellTagsIndexPosition[ 63799, 1665]
|
||||||
WindowFrame->Normal*)
|
WindowFrame->Normal*)
|
||||||
|
|
||||||
(* Beginning of Notebook Content *)
|
(* Beginning of Notebook Content *)
|
||||||
@ -76,234 +76,6 @@ Cell[BoxData["\<\"/Users/antonin/Development/Grid/lib/qcd/spin/gamma-gen\"\>"]\
|
|||||||
|
|
||||||
Cell[CellGroupData[{
|
Cell[CellGroupData[{
|
||||||
|
|
||||||
Cell[BoxData[
|
|
||||||
RowBox[{"FactorInteger", "[", "3152", "]"}]], "Input",
|
|
||||||
CellChangeTimes->{{3.7432347536316767`*^9, 3.7432347764739027`*^9}, {
|
|
||||||
3.743234833567358*^9,
|
|
||||||
3.743234862146022*^9}},ExpressionUUID->"d1a0fd03-85e1-43af-ba80-\
|
|
||||||
3ca4235675d8"],
|
|
||||||
|
|
||||||
Cell[BoxData[
|
|
||||||
RowBox[{"{",
|
|
||||||
RowBox[{
|
|
||||||
RowBox[{"{",
|
|
||||||
RowBox[{"2", ",", "4"}], "}"}], ",",
|
|
||||||
RowBox[{"{",
|
|
||||||
RowBox[{"197", ",", "1"}], "}"}]}], "}"}]], "Output",
|
|
||||||
CellChangeTimes->{{3.743234836792224*^9,
|
|
||||||
3.743234862493619*^9}},ExpressionUUID->"16d3f953-4b24-4ed2-ae62-\
|
|
||||||
306dcab66ca7"]
|
|
||||||
}, Open ]],
|
|
||||||
|
|
||||||
Cell[CellGroupData[{
|
|
||||||
|
|
||||||
Cell[BoxData[
|
|
||||||
RowBox[{"sol", "=",
|
|
||||||
RowBox[{"Solve", "[",
|
|
||||||
RowBox[{
|
|
||||||
RowBox[{
|
|
||||||
RowBox[{
|
|
||||||
SuperscriptBox["x", "2"], "+",
|
|
||||||
SuperscriptBox["y", "2"], "+",
|
|
||||||
SuperscriptBox["z", "2"]}], "\[Equal]", "2"}], ",",
|
|
||||||
RowBox[{"{",
|
|
||||||
RowBox[{"x", ",", "y", ",", "z"}], "}"}], ",", "Integers"}],
|
|
||||||
"]"}]}]], "Input",
|
|
||||||
CellChangeTimes->{{3.743235304127721*^9,
|
|
||||||
3.7432353087929983`*^9}},ExpressionUUID->"f0fa2a5c-3d81-4d75-a447-\
|
|
||||||
50c7ca3459ff"],
|
|
||||||
|
|
||||||
Cell[BoxData[
|
|
||||||
RowBox[{"{",
|
|
||||||
RowBox[{
|
|
||||||
RowBox[{"{",
|
|
||||||
RowBox[{
|
|
||||||
RowBox[{"x", "\[Rule]",
|
|
||||||
RowBox[{"-", "1"}]}], ",",
|
|
||||||
RowBox[{"y", "\[Rule]",
|
|
||||||
RowBox[{"-", "1"}]}], ",",
|
|
||||||
RowBox[{"z", "\[Rule]", "0"}]}], "}"}], ",",
|
|
||||||
RowBox[{"{",
|
|
||||||
RowBox[{
|
|
||||||
RowBox[{"x", "\[Rule]",
|
|
||||||
RowBox[{"-", "1"}]}], ",",
|
|
||||||
RowBox[{"y", "\[Rule]", "0"}], ",",
|
|
||||||
RowBox[{"z", "\[Rule]",
|
|
||||||
RowBox[{"-", "1"}]}]}], "}"}], ",",
|
|
||||||
RowBox[{"{",
|
|
||||||
RowBox[{
|
|
||||||
RowBox[{"x", "\[Rule]",
|
|
||||||
RowBox[{"-", "1"}]}], ",",
|
|
||||||
RowBox[{"y", "\[Rule]", "0"}], ",",
|
|
||||||
RowBox[{"z", "\[Rule]", "1"}]}], "}"}], ",",
|
|
||||||
RowBox[{"{",
|
|
||||||
RowBox[{
|
|
||||||
RowBox[{"x", "\[Rule]",
|
|
||||||
RowBox[{"-", "1"}]}], ",",
|
|
||||||
RowBox[{"y", "\[Rule]", "1"}], ",",
|
|
||||||
RowBox[{"z", "\[Rule]", "0"}]}], "}"}], ",",
|
|
||||||
RowBox[{"{",
|
|
||||||
RowBox[{
|
|
||||||
RowBox[{"x", "\[Rule]", "0"}], ",",
|
|
||||||
RowBox[{"y", "\[Rule]",
|
|
||||||
RowBox[{"-", "1"}]}], ",",
|
|
||||||
RowBox[{"z", "\[Rule]",
|
|
||||||
RowBox[{"-", "1"}]}]}], "}"}], ",",
|
|
||||||
RowBox[{"{",
|
|
||||||
RowBox[{
|
|
||||||
RowBox[{"x", "\[Rule]", "0"}], ",",
|
|
||||||
RowBox[{"y", "\[Rule]",
|
|
||||||
RowBox[{"-", "1"}]}], ",",
|
|
||||||
RowBox[{"z", "\[Rule]", "1"}]}], "}"}], ",",
|
|
||||||
RowBox[{"{",
|
|
||||||
RowBox[{
|
|
||||||
RowBox[{"x", "\[Rule]", "0"}], ",",
|
|
||||||
RowBox[{"y", "\[Rule]", "1"}], ",",
|
|
||||||
RowBox[{"z", "\[Rule]",
|
|
||||||
RowBox[{"-", "1"}]}]}], "}"}], ",",
|
|
||||||
RowBox[{"{",
|
|
||||||
RowBox[{
|
|
||||||
RowBox[{"x", "\[Rule]", "0"}], ",",
|
|
||||||
RowBox[{"y", "\[Rule]", "1"}], ",",
|
|
||||||
RowBox[{"z", "\[Rule]", "1"}]}], "}"}], ",",
|
|
||||||
RowBox[{"{",
|
|
||||||
RowBox[{
|
|
||||||
RowBox[{"x", "\[Rule]", "1"}], ",",
|
|
||||||
RowBox[{"y", "\[Rule]",
|
|
||||||
RowBox[{"-", "1"}]}], ",",
|
|
||||||
RowBox[{"z", "\[Rule]", "0"}]}], "}"}], ",",
|
|
||||||
RowBox[{"{",
|
|
||||||
RowBox[{
|
|
||||||
RowBox[{"x", "\[Rule]", "1"}], ",",
|
|
||||||
RowBox[{"y", "\[Rule]", "0"}], ",",
|
|
||||||
RowBox[{"z", "\[Rule]",
|
|
||||||
RowBox[{"-", "1"}]}]}], "}"}], ",",
|
|
||||||
RowBox[{"{",
|
|
||||||
RowBox[{
|
|
||||||
RowBox[{"x", "\[Rule]", "1"}], ",",
|
|
||||||
RowBox[{"y", "\[Rule]", "0"}], ",",
|
|
||||||
RowBox[{"z", "\[Rule]", "1"}]}], "}"}], ",",
|
|
||||||
RowBox[{"{",
|
|
||||||
RowBox[{
|
|
||||||
RowBox[{"x", "\[Rule]", "1"}], ",",
|
|
||||||
RowBox[{"y", "\[Rule]", "1"}], ",",
|
|
||||||
RowBox[{"z", "\[Rule]", "0"}]}], "}"}]}], "}"}]], "Output",
|
|
||||||
CellChangeTimes->{{3.743235305220907*^9,
|
|
||||||
3.743235309139554*^9}},ExpressionUUID->"d9825c95-24bb-442a-8734-\
|
|
||||||
4c0f47e99dfc"]
|
|
||||||
}, Open ]],
|
|
||||||
|
|
||||||
Cell[BoxData[
|
|
||||||
RowBox[{
|
|
||||||
RowBox[{"xmlElem", "[", "x_", "]"}], ":=",
|
|
||||||
RowBox[{"Print", "[",
|
|
||||||
RowBox[{"\"\<<elem>\>\"", "<>",
|
|
||||||
RowBox[{"ToString", "[",
|
|
||||||
RowBox[{"x", "[",
|
|
||||||
RowBox[{"[", "1", "]"}], "]"}], "]"}], "<>", "\"\< \>\"", "<>",
|
|
||||||
RowBox[{"ToString", "[",
|
|
||||||
RowBox[{"x", "[",
|
|
||||||
RowBox[{"[", "2", "]"}], "]"}], "]"}], "<>", "\"\< \>\"", "<>",
|
|
||||||
RowBox[{"ToString", "[",
|
|
||||||
RowBox[{"x", "[",
|
|
||||||
RowBox[{"[", "3", "]"}], "]"}], "]"}], "<>", "\"\<</elem>\>\""}],
|
|
||||||
"]"}]}]], "Input",
|
|
||||||
CellChangeTimes->{{3.74323534002862*^9, 3.743235351000985*^9}, {
|
|
||||||
3.743235403233039*^9, 3.743235413488028*^9}, {3.743235473169856*^9,
|
|
||||||
3.7432354747126904`*^9}},ExpressionUUID->"aea76313-c89e-45e8-b429-\
|
|
||||||
3f454091666d"],
|
|
||||||
|
|
||||||
Cell[CellGroupData[{
|
|
||||||
|
|
||||||
Cell[BoxData[
|
|
||||||
RowBox[{
|
|
||||||
RowBox[{
|
|
||||||
RowBox[{"xmlElem", "[",
|
|
||||||
RowBox[{
|
|
||||||
RowBox[{"{",
|
|
||||||
RowBox[{"x", ",", "y", ",", "z"}], "}"}], "/.", "#"}], "]"}], "&"}], "/@",
|
|
||||||
"sol"}]], "Input",
|
|
||||||
CellChangeTimes->{{3.743235415820318*^9,
|
|
||||||
3.743235467025091*^9}},ExpressionUUID->"07da3998-8eab-40ba-8c0b-\
|
|
||||||
ac6b130cb4fb"],
|
|
||||||
|
|
||||||
Cell[CellGroupData[{
|
|
||||||
|
|
||||||
Cell[BoxData["\<\"<elem>-1 -1 0</elem>\"\>"], "Print",
|
|
||||||
CellChangeTimes->{
|
|
||||||
3.743235476581676*^9},ExpressionUUID->"c577ba06-b67a-405a-9ff5-\
|
|
||||||
2bf7dc898d03"],
|
|
||||||
|
|
||||||
Cell[BoxData["\<\"<elem>-1 0 -1</elem>\"\>"], "Print",
|
|
||||||
CellChangeTimes->{
|
|
||||||
3.743235476588011*^9},ExpressionUUID->"d041aa36-0cea-457c-9d4b-\
|
|
||||||
1fe9be66e2ab"],
|
|
||||||
|
|
||||||
Cell[BoxData["\<\"<elem>-1 0 1</elem>\"\>"], "Print",
|
|
||||||
CellChangeTimes->{
|
|
||||||
3.743235476596887*^9},ExpressionUUID->"bf141b55-86b2-4430-a994-\
|
|
||||||
5c03d5a19441"],
|
|
||||||
|
|
||||||
Cell[BoxData["\<\"<elem>-1 1 0</elem>\"\>"], "Print",
|
|
||||||
CellChangeTimes->{
|
|
||||||
3.743235476605785*^9},ExpressionUUID->"4968a660-4ecf-4b66-9071-\
|
|
||||||
8bd798c18d21"],
|
|
||||||
|
|
||||||
Cell[BoxData["\<\"<elem>0 -1 -1</elem>\"\>"], "Print",
|
|
||||||
CellChangeTimes->{
|
|
||||||
3.743235476613523*^9},ExpressionUUID->"4e22d943-2680-416b-a1d7-\
|
|
||||||
a16ca20b781f"],
|
|
||||||
|
|
||||||
Cell[BoxData["\<\"<elem>0 -1 1</elem>\"\>"], "Print",
|
|
||||||
CellChangeTimes->{
|
|
||||||
3.7432354766218576`*^9},ExpressionUUID->"6dd38385-08b3-4dd9-932f-\
|
|
||||||
98a00c6db1b2"],
|
|
||||||
|
|
||||||
Cell[BoxData["\<\"<elem>0 1 -1</elem>\"\>"], "Print",
|
|
||||||
CellChangeTimes->{
|
|
||||||
3.743235476629427*^9},ExpressionUUID->"ef3baad3-91d1-4735-9a22-\
|
|
||||||
53495a624c15"],
|
|
||||||
|
|
||||||
Cell[BoxData["\<\"<elem>0 1 1</elem>\"\>"], "Print",
|
|
||||||
CellChangeTimes->{
|
|
||||||
3.743235476638257*^9},ExpressionUUID->"413fbb68-5017-4272-a62a-\
|
|
||||||
fa234e6daaea"],
|
|
||||||
|
|
||||||
Cell[BoxData["\<\"<elem>1 -1 0</elem>\"\>"], "Print",
|
|
||||||
CellChangeTimes->{
|
|
||||||
3.743235476646203*^9},ExpressionUUID->"3a832a60-ae00-414b-a9ac-\
|
|
||||||
f5e86e67e917"],
|
|
||||||
|
|
||||||
Cell[BoxData["\<\"<elem>1 0 -1</elem>\"\>"], "Print",
|
|
||||||
CellChangeTimes->{
|
|
||||||
3.743235476653907*^9},ExpressionUUID->"bfc79ef6-f6c7-4f1e-88e8-\
|
|
||||||
005ac314be9c"],
|
|
||||||
|
|
||||||
Cell[BoxData["\<\"<elem>1 0 1</elem>\"\>"], "Print",
|
|
||||||
CellChangeTimes->{
|
|
||||||
3.743235476662575*^9},ExpressionUUID->"0f892891-f885-489c-9925-\
|
|
||||||
ddef4d698410"],
|
|
||||||
|
|
||||||
Cell[BoxData["\<\"<elem>1 1 0</elem>\"\>"], "Print",
|
|
||||||
CellChangeTimes->{
|
|
||||||
3.7432354766702337`*^9},ExpressionUUID->"2906f190-e673-4f33-9c34-\
|
|
||||||
e8e56efe7a27"]
|
|
||||||
}, Open ]],
|
|
||||||
|
|
||||||
Cell[BoxData[
|
|
||||||
RowBox[{"{",
|
|
||||||
RowBox[{
|
|
||||||
"Null", ",", "Null", ",", "Null", ",", "Null", ",", "Null", ",", "Null",
|
|
||||||
",", "Null", ",", "Null", ",", "Null", ",", "Null", ",", "Null", ",",
|
|
||||||
"Null"}], "}"}]], "Output",
|
|
||||||
CellChangeTimes->{
|
|
||||||
3.7432354246225967`*^9, {3.7432354674878073`*^9,
|
|
||||||
3.743235476678007*^9}},ExpressionUUID->"500ca3c1-88d8-46e5-a1a1-\
|
|
||||||
86a7878e5638"]
|
|
||||||
}, Open ]],
|
|
||||||
|
|
||||||
Cell[CellGroupData[{
|
|
||||||
|
|
||||||
Cell["Clifford algebra generation", "Section",
|
Cell["Clifford algebra generation", "Section",
|
||||||
CellChangeTimes->{{3.6942089434583883`*^9,
|
CellChangeTimes->{{3.6942089434583883`*^9,
|
||||||
3.694208978559093*^9}},ExpressionUUID->"a5b064b3-3011-4922-8559-\
|
3.694208978559093*^9}},ExpressionUUID->"a5b064b3-3011-4922-8559-\
|
||||||
@ -1048,9 +820,10 @@ generated by the Mathematica notebook gamma-gen/gamma-gen.nb\n\n#include \
|
|||||||
"\"\< static const std::array<const char *, nGamma> \
|
"\"\< static const std::array<const char *, nGamma> \
|
||||||
name;\n static const std::array<std::array<Algebra, nGamma>, nGamma> mul;\n\
|
name;\n static const std::array<std::array<Algebra, nGamma>, nGamma> mul;\n\
|
||||||
static const std::array<Algebra, nGamma> adj;\n \
|
static const std::array<Algebra, nGamma> adj;\n \
|
||||||
static const std::array<const Gamma, 4> gmu;\n \
|
static const std::array<const Gamma, 4> gmu;\n static \
|
||||||
Algebra g;\n public:\n \
|
const std::array<const Gamma, 16> gall;\n Algebra \
|
||||||
Gamma(Algebra initg): g(initg) {} \n};\n\n\>\""}]}], ";",
|
g;\n public:\n \
|
||||||
|
Gamma(Algebra initg): g(initg) {} \n};\n\n\>\""}]}], ";",
|
||||||
"\[IndentingNewLine]",
|
"\[IndentingNewLine]",
|
||||||
RowBox[{"out", " ", "=",
|
RowBox[{"out", " ", "=",
|
||||||
RowBox[{"out", "<>", "funcCode"}]}], ";", "\[IndentingNewLine]",
|
RowBox[{"out", "<>", "funcCode"}]}], ";", "\[IndentingNewLine]",
|
||||||
@ -1076,7 +849,8 @@ Algebra g;\n public:\n \
|
|||||||
3.694963343265525*^9}, {3.694964367519239*^9, 3.69496439461199*^9}, {
|
3.694963343265525*^9}, {3.694964367519239*^9, 3.69496439461199*^9}, {
|
||||||
3.694964462130747*^9, 3.6949644669959793`*^9}, 3.694964509762739*^9, {
|
3.694964462130747*^9, 3.6949644669959793`*^9}, 3.694964509762739*^9, {
|
||||||
3.694964705045744*^9, 3.694964723148797*^9}, {3.694964992988984*^9,
|
3.694964705045744*^9, 3.694964723148797*^9}, {3.694964992988984*^9,
|
||||||
3.6949649968504257`*^9}},ExpressionUUID->"c7103bd6-b539-4495-b98c-\
|
3.6949649968504257`*^9}, {3.758291687176977*^9,
|
||||||
|
3.758291694181189*^9}},ExpressionUUID->"c7103bd6-b539-4495-b98c-\
|
||||||
d4d12ac6cad8"],
|
d4d12ac6cad8"],
|
||||||
|
|
||||||
Cell["Gamma enum generation:", "Text",
|
Cell["Gamma enum generation:", "Text",
|
||||||
@ -1745,8 +1519,17 @@ namespace QCD {\>\""}]}], ";", "\[IndentingNewLine]",
|
|||||||
"\"\<\n\nconst std::array<const Gamma, 4> Gamma::gmu = {{\n \
|
"\"\<\n\nconst std::array<const Gamma, 4> Gamma::gmu = {{\n \
|
||||||
Gamma(Gamma::Algebra::GammaX),\n Gamma(Gamma::Algebra::GammaY),\n \
|
Gamma(Gamma::Algebra::GammaX),\n Gamma(Gamma::Algebra::GammaY),\n \
|
||||||
Gamma(Gamma::Algebra::GammaZ),\n Gamma(Gamma::Algebra::GammaT)}};\n\nconst \
|
Gamma(Gamma::Algebra::GammaZ),\n Gamma(Gamma::Algebra::GammaT)}};\n\nconst \
|
||||||
std::array<const char *, Gamma::nGamma> Gamma::name = {{\n\>\""}]}], ";",
|
std::array<const Gamma, 16> Gamma::gall = {{\n \
|
||||||
"\[IndentingNewLine]",
|
Gamma(Gamma::Algebra::Identity),\n Gamma(Gamma::Algebra::Gamma5),\n \
|
||||||
|
Gamma(Gamma::Algebra::GammaX),\n Gamma(Gamma::Algebra::GammaY),\n \
|
||||||
|
Gamma(Gamma::Algebra::GammaZ),\n Gamma(Gamma::Algebra::GammaT),\n \
|
||||||
|
Gamma(Gamma::Algebra::GammaXGamma5),\n Gamma(Gamma::Algebra::GammaYGamma5),\n\
|
||||||
|
Gamma(Gamma::Algebra::GammaZGamma5),\n \
|
||||||
|
Gamma(Gamma::Algebra::GammaTGamma5),\n Gamma(Gamma::Algebra::SigmaXT), \
|
||||||
|
\n Gamma(Gamma::Algebra::SigmaXY), \n Gamma(Gamma::Algebra::SigmaXZ), \
|
||||||
|
\n Gamma(Gamma::Algebra::SigmaYT),\n Gamma(Gamma::Algebra::SigmaYZ),\n \
|
||||||
|
Gamma(Gamma::Algebra::SigmaZT)}};\n\nconst std::array<const char *, \
|
||||||
|
Gamma::nGamma> Gamma::name = {{\n\>\""}]}], ";", "\[IndentingNewLine]",
|
||||||
RowBox[{"Do", "[", "\[IndentingNewLine]",
|
RowBox[{"Do", "[", "\[IndentingNewLine]",
|
||||||
RowBox[{
|
RowBox[{
|
||||||
RowBox[{"out", " ", "=", " ",
|
RowBox[{"out", " ", "=", " ",
|
||||||
@ -1847,7 +1630,9 @@ Gamma::nGamma> Gamma::mul = {{\\n\>\""}]}], ";", "\[IndentingNewLine]",
|
|||||||
3.694963031525289*^9}, {3.694963065828494*^9, 3.694963098327538*^9}, {
|
3.694963031525289*^9}, {3.694963065828494*^9, 3.694963098327538*^9}, {
|
||||||
3.6949632020836153`*^9, 3.6949632715940027`*^9}, {3.694963440035037*^9,
|
3.6949632020836153`*^9, 3.6949632715940027`*^9}, {3.694963440035037*^9,
|
||||||
3.6949634418966017`*^9}, {3.6949651447067547`*^9, 3.694965161228381*^9}, {
|
3.6949634418966017`*^9}, {3.6949651447067547`*^9, 3.694965161228381*^9}, {
|
||||||
3.694967957845581*^9, 3.694967958364184*^9}}],
|
3.694967957845581*^9, 3.694967958364184*^9}, {3.758291673792514*^9,
|
||||||
|
3.758291676983432*^9}},ExpressionUUID->"b1b309f8-a3a7-4081-a781-\
|
||||||
|
c3845e3cd372"],
|
||||||
|
|
||||||
Cell[BoxData[
|
Cell[BoxData[
|
||||||
RowBox[{
|
RowBox[{
|
||||||
@ -1867,8 +1652,8 @@ Cell[BoxData[""], "Input",
|
|||||||
},
|
},
|
||||||
WindowSize->{1246, 1005},
|
WindowSize->{1246, 1005},
|
||||||
WindowMargins->{{282, Automatic}, {Automatic, 14}},
|
WindowMargins->{{282, Automatic}, {Automatic, 14}},
|
||||||
FrontEndVersion->"11.2 for Mac OS X x86 (32-bit, 64-bit Kernel) (September \
|
FrontEndVersion->"11.3 for Mac OS X x86 (32-bit, 64-bit Kernel) (March 5, \
|
||||||
10, 2017)",
|
2018)",
|
||||||
StyleDefinitions->"Default.nb"
|
StyleDefinitions->"Default.nb"
|
||||||
]
|
]
|
||||||
(* End of Notebook Content *)
|
(* End of Notebook Content *)
|
||||||
@ -1888,75 +1673,48 @@ Cell[1948, 43, 570, 11, 73, "Input",ExpressionUUID->"5c937a3e-adfd-4d7e-8fde-afb
|
|||||||
Cell[2521, 56, 1172, 17, 34, "Output",ExpressionUUID->"72817ba6-2f6a-4a4d-8212-6f0970f49e7c"]
|
Cell[2521, 56, 1172, 17, 34, "Output",ExpressionUUID->"72817ba6-2f6a-4a4d-8212-6f0970f49e7c"]
|
||||||
}, Open ]],
|
}, Open ]],
|
||||||
Cell[CellGroupData[{
|
Cell[CellGroupData[{
|
||||||
Cell[3730, 78, 248, 5, 30, "Input",ExpressionUUID->"d1a0fd03-85e1-43af-ba80-3ca4235675d8"],
|
Cell[3730, 78, 174, 3, 67, "Section",ExpressionUUID->"a5b064b3-3011-4922-8559-ead857cad102"],
|
||||||
Cell[3981, 85, 299, 9, 34, "Output",ExpressionUUID->"16d3f953-4b24-4ed2-ae62-306dcab66ca7"]
|
Cell[3907, 83, 535, 16, 52, "Input",ExpressionUUID->"aa28f02b-31e1-4df2-9b5d-482177464b59"],
|
||||||
|
Cell[4445, 101, 250, 4, 35, "Text",ExpressionUUID->"c8896b88-f1db-4ce4-b7a6-0c9838bdb8f1"],
|
||||||
|
Cell[4698, 107, 5511, 169, 425, "Input",ExpressionUUID->"52a96ff6-047e-4043-86d0-e303866e5f8e"],
|
||||||
|
Cell[CellGroupData[{
|
||||||
|
Cell[10234, 280, 2183, 58, 135, "Input",ExpressionUUID->"8b0f4955-2c3f-418c-9226-9be8f87621e8"],
|
||||||
|
Cell[12420, 340, 1027, 27, 56, "Output",ExpressionUUID->"edd0619f-6f12-4070-a1d2-6b547877fadc"]
|
||||||
}, Open ]],
|
}, Open ]],
|
||||||
Cell[CellGroupData[{
|
Cell[CellGroupData[{
|
||||||
Cell[4317, 99, 469, 14, 33, "Input",ExpressionUUID->"f0fa2a5c-3d81-4d75-a447-50c7ca3459ff"],
|
Cell[13484, 372, 1543, 46, 114, "Input",ExpressionUUID->"fb45123c-c610-4075-99b0-7cd71c728ae7"],
|
||||||
Cell[4789, 115, 2423, 77, 56, "Output",ExpressionUUID->"d9825c95-24bb-442a-8734-4c0f47e99dfc"]
|
Cell[15030, 420, 1311, 32, 87, "Output",ExpressionUUID->"2ae14565-b412-4dc0-9dce-bd6c1ba5ef27"]
|
||||||
}, Open ]],
|
}, Open ]],
|
||||||
Cell[7227, 195, 751, 18, 30, "Input",ExpressionUUID->"aea76313-c89e-45e8-b429-3f454091666d"],
|
Cell[16356, 455, 179, 3, 35, "Text",ExpressionUUID->"af247231-a58d-417b-987a-26908dafffdb"],
|
||||||
|
Cell[16538, 460, 2175, 65, 94, "Input",ExpressionUUID->"7c44cadd-e488-4f51-87d8-c64eef11f40c"],
|
||||||
|
Cell[18716, 527, 193, 3, 35, "Text",ExpressionUUID->"856f1746-1107-4509-a5ce-ac9c7f56cdb1"],
|
||||||
Cell[CellGroupData[{
|
Cell[CellGroupData[{
|
||||||
Cell[8003, 217, 323, 10, 30, "Input",ExpressionUUID->"07da3998-8eab-40ba-8c0b-ac6b130cb4fb"],
|
Cell[18934, 534, 536, 16, 30, "Input",ExpressionUUID->"8674484a-8543-434f-b177-3b27f9353212"],
|
||||||
Cell[CellGroupData[{
|
Cell[19473, 552, 1705, 35, 87, "Output",ExpressionUUID->"c3b3f84d-91f6-41af-af6b-a394ca020511"]
|
||||||
Cell[8351, 231, 156, 3, 24, "Print",ExpressionUUID->"c577ba06-b67a-405a-9ff5-2bf7dc898d03"],
|
|
||||||
Cell[8510, 236, 156, 3, 24, "Print",ExpressionUUID->"d041aa36-0cea-457c-9d4b-1fe9be66e2ab"],
|
|
||||||
Cell[8669, 241, 155, 3, 24, "Print",ExpressionUUID->"bf141b55-86b2-4430-a994-5c03d5a19441"],
|
|
||||||
Cell[8827, 246, 155, 3, 24, "Print",ExpressionUUID->"4968a660-4ecf-4b66-9071-8bd798c18d21"],
|
|
||||||
Cell[8985, 251, 156, 3, 24, "Print",ExpressionUUID->"4e22d943-2680-416b-a1d7-a16ca20b781f"],
|
|
||||||
Cell[9144, 256, 157, 3, 24, "Print",ExpressionUUID->"6dd38385-08b3-4dd9-932f-98a00c6db1b2"],
|
|
||||||
Cell[9304, 261, 155, 3, 24, "Print",ExpressionUUID->"ef3baad3-91d1-4735-9a22-53495a624c15"],
|
|
||||||
Cell[9462, 266, 154, 3, 24, "Print",ExpressionUUID->"413fbb68-5017-4272-a62a-fa234e6daaea"],
|
|
||||||
Cell[9619, 271, 155, 3, 24, "Print",ExpressionUUID->"3a832a60-ae00-414b-a9ac-f5e86e67e917"],
|
|
||||||
Cell[9777, 276, 155, 3, 24, "Print",ExpressionUUID->"bfc79ef6-f6c7-4f1e-88e8-005ac314be9c"],
|
|
||||||
Cell[9935, 281, 154, 3, 24, "Print",ExpressionUUID->"0f892891-f885-489c-9925-ddef4d698410"],
|
|
||||||
Cell[10092, 286, 156, 3, 24, "Print",ExpressionUUID->"2906f190-e673-4f33-9c34-e8e56efe7a27"]
|
|
||||||
}, Open ]],
|
|
||||||
Cell[10263, 292, 376, 9, 34, "Output",ExpressionUUID->"500ca3c1-88d8-46e5-a1a1-86a7878e5638"]
|
|
||||||
}, Open ]],
|
}, Open ]],
|
||||||
|
Cell[21193, 590, 170, 3, 35, "Text",ExpressionUUID->"518a3040-54b1-4d43-8947-5c7d12efa94d"],
|
||||||
Cell[CellGroupData[{
|
Cell[CellGroupData[{
|
||||||
Cell[10676, 306, 174, 3, 67, "Section",ExpressionUUID->"a5b064b3-3011-4922-8559-ead857cad102"],
|
Cell[21388, 597, 536, 14, 30, "Input",ExpressionUUID->"61a2e974-2b39-4a07-8043-2dfd39a70569"],
|
||||||
Cell[10853, 311, 535, 16, 52, "Input",ExpressionUUID->"aa28f02b-31e1-4df2-9b5d-482177464b59"],
|
Cell[21927, 613, 6754, 167, 303, "Output",ExpressionUUID->"73480ac0-3043-4077-80cc-b952a94c822a"]
|
||||||
Cell[11391, 329, 250, 4, 35, "Text",ExpressionUUID->"c8896b88-f1db-4ce4-b7a6-0c9838bdb8f1"],
|
|
||||||
Cell[11644, 335, 5511, 169, 425, "Input",ExpressionUUID->"52a96ff6-047e-4043-86d0-e303866e5f8e"],
|
|
||||||
Cell[CellGroupData[{
|
|
||||||
Cell[17180, 508, 2183, 58, 135, "Input",ExpressionUUID->"8b0f4955-2c3f-418c-9226-9be8f87621e8"],
|
|
||||||
Cell[19366, 568, 1027, 27, 67, "Output",ExpressionUUID->"edd0619f-6f12-4070-a1d2-6b547877fadc"]
|
|
||||||
}, Open ]],
|
|
||||||
Cell[CellGroupData[{
|
|
||||||
Cell[20430, 600, 1543, 46, 114, "Input",ExpressionUUID->"fb45123c-c610-4075-99b0-7cd71c728ae7"],
|
|
||||||
Cell[21976, 648, 1311, 32, 98, "Output",ExpressionUUID->"2ae14565-b412-4dc0-9dce-bd6c1ba5ef27"]
|
|
||||||
}, Open ]],
|
|
||||||
Cell[23302, 683, 179, 3, 35, "Text",ExpressionUUID->"af247231-a58d-417b-987a-26908dafffdb"],
|
|
||||||
Cell[23484, 688, 2175, 65, 94, "Input",ExpressionUUID->"7c44cadd-e488-4f51-87d8-c64eef11f40c"],
|
|
||||||
Cell[25662, 755, 193, 3, 35, "Text",ExpressionUUID->"856f1746-1107-4509-a5ce-ac9c7f56cdb1"],
|
|
||||||
Cell[CellGroupData[{
|
|
||||||
Cell[25880, 762, 536, 16, 30, "Input",ExpressionUUID->"8674484a-8543-434f-b177-3b27f9353212"],
|
|
||||||
Cell[26419, 780, 1705, 35, 87, "Output",ExpressionUUID->"c3b3f84d-91f6-41af-af6b-a394ca020511"]
|
|
||||||
}, Open ]],
|
|
||||||
Cell[28139, 818, 170, 3, 35, "Text",ExpressionUUID->"518a3040-54b1-4d43-8947-5c7d12efa94d"],
|
|
||||||
Cell[CellGroupData[{
|
|
||||||
Cell[28334, 825, 536, 14, 30, "Input",ExpressionUUID->"61a2e974-2b39-4a07-8043-2dfd39a70569"],
|
|
||||||
Cell[28873, 841, 6754, 167, 303, "Output",ExpressionUUID->"73480ac0-3043-4077-80cc-b952a94c822a"]
|
|
||||||
}, Open ]]
|
}, Open ]]
|
||||||
}, Open ]],
|
}, Open ]],
|
||||||
Cell[CellGroupData[{
|
Cell[CellGroupData[{
|
||||||
Cell[35676, 1014, 226, 4, 67, "Section",ExpressionUUID->"4e833cd6-9f0e-4aa3-a873-3d579e874720"],
|
Cell[28730, 786, 226, 4, 67, "Section",ExpressionUUID->"4e833cd6-9f0e-4aa3-a873-3d579e874720"],
|
||||||
Cell[35905, 1020, 188, 4, 44, "Text",ExpressionUUID->"6d27fc04-3a60-4e03-8df7-3dd3aeee35b4"],
|
Cell[28959, 792, 188, 4, 44, "Text",ExpressionUUID->"6d27fc04-3a60-4e03-8df7-3dd3aeee35b4"],
|
||||||
Cell[36096, 1026, 2980, 53, 703, "Input",ExpressionUUID->"c7103bd6-b539-4495-b98c-d4d12ac6cad8"],
|
Cell[29150, 798, 3104, 55, 724, "Input",ExpressionUUID->"c7103bd6-b539-4495-b98c-d4d12ac6cad8"],
|
||||||
Cell[39079, 1081, 221, 4, 44, "Text",ExpressionUUID->"0625593d-290f-4a39-9d80-8e2c6fdbc94e"],
|
Cell[32257, 855, 221, 4, 44, "Text",ExpressionUUID->"0625593d-290f-4a39-9d80-8e2c6fdbc94e"],
|
||||||
Cell[39303, 1087, 4936, 150, 682, "Input",ExpressionUUID->"1ad4904c-352f-4b1d-a7c7-91e1b0549409"],
|
Cell[32481, 861, 4936, 150, 682, "Input",ExpressionUUID->"1ad4904c-352f-4b1d-a7c7-91e1b0549409"],
|
||||||
Cell[44242, 1239, 2645, 56, 199, "Input",ExpressionUUID->"0221674f-9b63-4662-91bc-ccc8c6ae9589"],
|
Cell[37420, 1013, 2645, 56, 199, "Input",ExpressionUUID->"0221674f-9b63-4662-91bc-ccc8c6ae9589"],
|
||||||
Cell[46890, 1297, 209, 4, 44, "Text",ExpressionUUID->"d2d2257a-487b-416f-bc40-abd4482225f7"],
|
Cell[40068, 1071, 209, 4, 44, "Text",ExpressionUUID->"d2d2257a-487b-416f-bc40-abd4482225f7"],
|
||||||
Cell[47102, 1303, 15306, 397, 2131, "Input",ExpressionUUID->"daea68a9-c9e8-46ab-9bc8-5186e2cf477c"],
|
Cell[40280, 1077, 15306, 397, 2131, "Input",ExpressionUUID->"daea68a9-c9e8-46ab-9bc8-5186e2cf477c"],
|
||||||
Cell[62411, 1702, 137, 2, 44, "Text",ExpressionUUID->"76ba9d5a-7ee3-4888-be7e-6377003275e8"],
|
Cell[55589, 1476, 137, 2, 44, "Text",ExpressionUUID->"76ba9d5a-7ee3-4888-be7e-6377003275e8"],
|
||||||
Cell[62551, 1706, 521, 12, 30, "Input",ExpressionUUID->"4ec61f4c-3fd3-49ea-b5ef-6f7f04a16b34"]
|
Cell[55729, 1480, 521, 12, 30, "Input",ExpressionUUID->"4ec61f4c-3fd3-49ea-b5ef-6f7f04a16b34"]
|
||||||
}, Open ]],
|
}, Open ]],
|
||||||
Cell[CellGroupData[{
|
Cell[CellGroupData[{
|
||||||
Cell[63109, 1723, 167, 2, 67, "Section",ExpressionUUID->"a4458b3a-09b5-4e36-a1fc-781d6702b2dc"],
|
Cell[56287, 1497, 167, 2, 67, "Section",ExpressionUUID->"a4458b3a-09b5-4e36-a1fc-781d6702b2dc"],
|
||||||
Cell[63279, 1727, 5693, 122, 829, "Input",ExpressionUUID->"b1b309f8-a3a7-4081-a781-c3845e3cd372"],
|
Cell[56457, 1501, 6464, 133, 1207, "Input",ExpressionUUID->"b1b309f8-a3a7-4081-a781-c3845e3cd372"],
|
||||||
Cell[68975, 1851, 448, 10, 30, "Input",ExpressionUUID->"cba42949-b0f2-42ce-aebd-ffadfd83ef88"],
|
Cell[62924, 1636, 448, 10, 30, "Input",ExpressionUUID->"cba42949-b0f2-42ce-aebd-ffadfd83ef88"],
|
||||||
Cell[69426, 1863, 94, 1, 30, "Input",ExpressionUUID->"6175b72c-af9f-43c2-b4ca-bd84c48a456d"]
|
Cell[63375, 1648, 94, 1, 30, "Input",ExpressionUUID->"6175b72c-af9f-43c2-b4ca-bd84c48a456d"]
|
||||||
}, Open ]]
|
}, Open ]]
|
||||||
}
|
}
|
||||||
]
|
]
|
||||||
|
87
Grid/qcd/utils/CovariantSmearing.h
Normal file
87
Grid/qcd/utils/CovariantSmearing.h
Normal file
@ -0,0 +1,87 @@
|
|||||||
|
/*************************************************************************************
|
||||||
|
|
||||||
|
Grid physics library, www.github.com/paboyle/Grid
|
||||||
|
|
||||||
|
Source file: ./lib/qcd/action/scalar/CovariantLaplacian.h
|
||||||
|
|
||||||
|
Copyright (C) 2016
|
||||||
|
|
||||||
|
Author: Azusa Yamaguchi
|
||||||
|
|
||||||
|
This program is free software; you can redistribute it and/or modify
|
||||||
|
it under the terms of the GNU General Public License as published by
|
||||||
|
the Free Software Foundation; either version 2 of the License, or
|
||||||
|
(at your option) any later version.
|
||||||
|
|
||||||
|
This program is distributed in the hope that it will be useful,
|
||||||
|
but WITHOUT ANY WARRANTY; without even the implied warranty of
|
||||||
|
MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the
|
||||||
|
GNU General Public License for more details.
|
||||||
|
|
||||||
|
You should have received a copy of the GNU General Public License along
|
||||||
|
with this program; if not, write to the Free Software Foundation, Inc.,
|
||||||
|
51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA.
|
||||||
|
|
||||||
|
See the full license in the file "LICENSE" in the top level distribution
|
||||||
|
directory
|
||||||
|
*************************************************************************************/
|
||||||
|
#pragma once
|
||||||
|
|
||||||
|
namespace Grid {
|
||||||
|
namespace QCD {
|
||||||
|
|
||||||
|
template <class Gimpl> class CovariantSmearing : public Gimpl
|
||||||
|
{
|
||||||
|
public:
|
||||||
|
INHERIT_GIMPL_TYPES(Gimpl);
|
||||||
|
|
||||||
|
typedef typename Gimpl::GaugeLinkField GaugeMat;
|
||||||
|
typedef typename Gimpl::GaugeField GaugeLorentz;
|
||||||
|
|
||||||
|
template<typename T>
|
||||||
|
static void GaussianSmear(const std::vector<LatticeColourMatrix>& U,
|
||||||
|
T& chi,
|
||||||
|
const Real& width, int Iterations, int orthog)
|
||||||
|
{
|
||||||
|
GridBase *grid = chi._grid;
|
||||||
|
T psi(grid);
|
||||||
|
|
||||||
|
////////////////////////////////////////////////////////////////////////////////////
|
||||||
|
// Follow Chroma conventions for width to keep compatibility with previous data
|
||||||
|
// Free field iterates
|
||||||
|
// chi = (1 - w^2/4N p^2)^N chi
|
||||||
|
//
|
||||||
|
// ~ (e^(-w^2/4N p^2)^N chi
|
||||||
|
// ~ (e^(-w^2/4 p^2) chi
|
||||||
|
// ~ (e^(-w'^2/2 p^2) chi [ w' = w/sqrt(2) ]
|
||||||
|
//
|
||||||
|
// Which in coordinate space is proportional to
|
||||||
|
//
|
||||||
|
// e^(-x^2/w^2) = e^(-x^2/2w'^2)
|
||||||
|
//
|
||||||
|
// The 4 is a bit unconventional from Gaussian width perspective, but... it's Chroma convention.
|
||||||
|
// 2nd derivative approx d^2/dx^2 = x+mu + x-mu - 2x
|
||||||
|
//
|
||||||
|
// d^2/dx^2 = - p^2
|
||||||
|
//
|
||||||
|
// chi = ( 1 + w^2/4N d^2/dx^2 )^N chi
|
||||||
|
//
|
||||||
|
////////////////////////////////////////////////////////////////////////////////////
|
||||||
|
Real coeff = (width*width) / Real(4*Iterations);
|
||||||
|
|
||||||
|
int dims = Nd;
|
||||||
|
if( orthog < Nd ) dims=Nd-1;
|
||||||
|
|
||||||
|
for(int n = 0; n < Iterations; ++n) {
|
||||||
|
psi = (-2.0*dims)*chi;
|
||||||
|
for(int mu=0;mu<Nd;mu++) {
|
||||||
|
if ( mu != orthog ) {
|
||||||
|
psi = psi + Gimpl::CovShiftForward(U[mu],mu,chi);
|
||||||
|
psi = psi + Gimpl::CovShiftBackward(U[mu],mu,chi);
|
||||||
|
}
|
||||||
|
}
|
||||||
|
chi = chi + coeff*psi;
|
||||||
|
}
|
||||||
|
}
|
||||||
|
};
|
||||||
|
}}
|
@ -53,21 +53,32 @@ class FourierAcceleratedGaugeFixer : public Gimpl {
|
|||||||
}
|
}
|
||||||
static void SteepestDescentGaugeFix(GaugeLorentz &Umu,Real & alpha,int maxiter,Real Omega_tol, Real Phi_tol,bool Fourier=false) {
|
static void SteepestDescentGaugeFix(GaugeLorentz &Umu,Real & alpha,int maxiter,Real Omega_tol, Real Phi_tol,bool Fourier=false) {
|
||||||
GridBase *grid = Umu._grid;
|
GridBase *grid = Umu._grid;
|
||||||
|
GaugeMat xform(grid);
|
||||||
|
SteepestDescentGaugeFix(Umu,xform,alpha,maxiter,Omega_tol,Phi_tol,Fourier);
|
||||||
|
}
|
||||||
|
static void SteepestDescentGaugeFix(GaugeLorentz &Umu,GaugeMat &xform,Real & alpha,int maxiter,Real Omega_tol, Real Phi_tol,bool Fourier=false) {
|
||||||
|
|
||||||
|
GridBase *grid = Umu._grid;
|
||||||
|
|
||||||
Real org_plaq =WilsonLoops<Gimpl>::avgPlaquette(Umu);
|
Real org_plaq =WilsonLoops<Gimpl>::avgPlaquette(Umu);
|
||||||
Real org_link_trace=WilsonLoops<Gimpl>::linkTrace(Umu);
|
Real org_link_trace=WilsonLoops<Gimpl>::linkTrace(Umu);
|
||||||
Real old_trace = org_link_trace;
|
Real old_trace = org_link_trace;
|
||||||
Real trG;
|
Real trG;
|
||||||
|
|
||||||
|
xform=1.0;
|
||||||
|
|
||||||
std::vector<GaugeMat> U(Nd,grid);
|
std::vector<GaugeMat> U(Nd,grid);
|
||||||
GaugeMat dmuAmu(grid);
|
|
||||||
|
GaugeMat dmuAmu(grid);
|
||||||
|
|
||||||
for(int i=0;i<maxiter;i++){
|
for(int i=0;i<maxiter;i++){
|
||||||
|
|
||||||
for(int mu=0;mu<Nd;mu++) U[mu]= PeekIndex<LorentzIndex>(Umu,mu);
|
for(int mu=0;mu<Nd;mu++) U[mu]= PeekIndex<LorentzIndex>(Umu,mu);
|
||||||
|
|
||||||
if ( Fourier==false ) {
|
if ( Fourier==false ) {
|
||||||
trG = SteepestDescentStep(U,alpha,dmuAmu);
|
trG = SteepestDescentStep(U,xform,alpha,dmuAmu);
|
||||||
} else {
|
} else {
|
||||||
trG = FourierAccelSteepestDescentStep(U,alpha,dmuAmu);
|
trG = FourierAccelSteepestDescentStep(U,xform,alpha,dmuAmu);
|
||||||
}
|
}
|
||||||
for(int mu=0;mu<Nd;mu++) PokeIndex<LorentzIndex>(Umu,U[mu],mu);
|
for(int mu=0;mu<Nd;mu++) PokeIndex<LorentzIndex>(Umu,U[mu],mu);
|
||||||
// Monitor progress and convergence test
|
// Monitor progress and convergence test
|
||||||
@ -84,7 +95,6 @@ class FourierAcceleratedGaugeFixer : public Gimpl {
|
|||||||
Real Phi = 1.0 - old_trace / link_trace ;
|
Real Phi = 1.0 - old_trace / link_trace ;
|
||||||
Real Omega= 1.0 - trG;
|
Real Omega= 1.0 - trG;
|
||||||
|
|
||||||
|
|
||||||
std::cout << GridLogMessage << " Iteration "<<i<< " Phi= "<<Phi<< " Omega= " << Omega<< " trG " << trG <<std::endl;
|
std::cout << GridLogMessage << " Iteration "<<i<< " Phi= "<<Phi<< " Omega= " << Omega<< " trG " << trG <<std::endl;
|
||||||
if ( (Omega < Omega_tol) && ( ::fabs(Phi) < Phi_tol) ) {
|
if ( (Omega < Omega_tol) && ( ::fabs(Phi) < Phi_tol) ) {
|
||||||
std::cout << GridLogMessage << "Converged ! "<<std::endl;
|
std::cout << GridLogMessage << "Converged ! "<<std::endl;
|
||||||
@ -96,7 +106,7 @@ class FourierAcceleratedGaugeFixer : public Gimpl {
|
|||||||
}
|
}
|
||||||
}
|
}
|
||||||
};
|
};
|
||||||
static Real SteepestDescentStep(std::vector<GaugeMat> &U,Real & alpha, GaugeMat & dmuAmu) {
|
static Real SteepestDescentStep(std::vector<GaugeMat> &U,GaugeMat &xform,Real & alpha, GaugeMat & dmuAmu) {
|
||||||
GridBase *grid = U[0]._grid;
|
GridBase *grid = U[0]._grid;
|
||||||
|
|
||||||
std::vector<GaugeMat> A(Nd,grid);
|
std::vector<GaugeMat> A(Nd,grid);
|
||||||
@ -109,12 +119,13 @@ class FourierAcceleratedGaugeFixer : public Gimpl {
|
|||||||
Real vol = grid->gSites();
|
Real vol = grid->gSites();
|
||||||
Real trG = TensorRemove(sum(trace(g))).real()/vol/Nc;
|
Real trG = TensorRemove(sum(trace(g))).real()/vol/Nc;
|
||||||
|
|
||||||
|
xform = g*xform ;
|
||||||
SU<Nc>::GaugeTransform(U,g);
|
SU<Nc>::GaugeTransform(U,g);
|
||||||
|
|
||||||
return trG;
|
return trG;
|
||||||
}
|
}
|
||||||
|
|
||||||
static Real FourierAccelSteepestDescentStep(std::vector<GaugeMat> &U,Real & alpha, GaugeMat & dmuAmu) {
|
static Real FourierAccelSteepestDescentStep(std::vector<GaugeMat> &U,GaugeMat &xform,Real & alpha, GaugeMat & dmuAmu) {
|
||||||
|
|
||||||
GridBase *grid = U[0]._grid;
|
GridBase *grid = U[0]._grid;
|
||||||
|
|
||||||
@ -153,13 +164,6 @@ class FourierAcceleratedGaugeFixer : public Gimpl {
|
|||||||
Complex psqMax(16.0);
|
Complex psqMax(16.0);
|
||||||
Fp = psqMax*one/psq;
|
Fp = psqMax*one/psq;
|
||||||
|
|
||||||
/*
|
|
||||||
static int once;
|
|
||||||
if ( once == 0 ) {
|
|
||||||
std::cout << " Fp " << Fp <<std::endl;
|
|
||||||
once ++;
|
|
||||||
}*/
|
|
||||||
|
|
||||||
pokeSite(TComplex(1.0),Fp,coor);
|
pokeSite(TComplex(1.0),Fp,coor);
|
||||||
|
|
||||||
dmuAmu_p = dmuAmu_p * Fp;
|
dmuAmu_p = dmuAmu_p * Fp;
|
||||||
@ -173,6 +177,7 @@ class FourierAcceleratedGaugeFixer : public Gimpl {
|
|||||||
|
|
||||||
Real trG = TensorRemove(sum(trace(g))).real()/vol/Nc;
|
Real trG = TensorRemove(sum(trace(g))).real()/vol/Nc;
|
||||||
|
|
||||||
|
xform = g*xform ;
|
||||||
SU<Nc>::GaugeTransform(U,g);
|
SU<Nc>::GaugeTransform(U,g);
|
||||||
|
|
||||||
return trG;
|
return trG;
|
||||||
|
@ -676,10 +676,18 @@ class SU {
|
|||||||
}
|
}
|
||||||
}
|
}
|
||||||
/*
|
/*
|
||||||
add GaugeTrans
|
* Fundamental rep gauge xform
|
||||||
*/
|
*/
|
||||||
|
template<typename Fundamental,typename GaugeMat>
|
||||||
template<typename GaugeField,typename GaugeMat>
|
static void GaugeTransformFundamental( Fundamental &ferm, GaugeMat &g){
|
||||||
|
GridBase *grid = ferm._grid;
|
||||||
|
conformable(grid,g._grid);
|
||||||
|
ferm = g*ferm;
|
||||||
|
}
|
||||||
|
/*
|
||||||
|
* Adjoint rep gauge xform
|
||||||
|
*/
|
||||||
|
template<typename GaugeField,typename GaugeMat>
|
||||||
static void GaugeTransform( GaugeField &Umu, GaugeMat &g){
|
static void GaugeTransform( GaugeField &Umu, GaugeMat &g){
|
||||||
GridBase *grid = Umu._grid;
|
GridBase *grid = Umu._grid;
|
||||||
conformable(grid,g._grid);
|
conformable(grid,g._grid);
|
||||||
|
@ -289,6 +289,11 @@ void Grid_init(int *argc,char ***argv)
|
|||||||
std::cout << "MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the"<<std::endl;
|
std::cout << "MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the"<<std::endl;
|
||||||
std::cout << "GNU General Public License for more details."<<std::endl;
|
std::cout << "GNU General Public License for more details."<<std::endl;
|
||||||
printHash();
|
printHash();
|
||||||
|
#ifdef GRID_BUILD_REF
|
||||||
|
#define _GRID_BUILD_STR(x) #x
|
||||||
|
#define GRID_BUILD_STR(x) _GRID_BUILD_STR(x)
|
||||||
|
std::cout << "Build " << GRID_BUILD_STR(GRID_BUILD_REF) << std::endl;
|
||||||
|
#endif
|
||||||
std::cout << std::endl;
|
std::cout << std::endl;
|
||||||
}
|
}
|
||||||
|
|
||||||
|
@ -4,7 +4,7 @@ Grid physics library, www.github.com/paboyle/Grid
|
|||||||
|
|
||||||
Source file: Hadrons/A2AMatrix.hpp
|
Source file: Hadrons/A2AMatrix.hpp
|
||||||
|
|
||||||
Copyright (C) 2015-2018
|
Copyright (C) 2015-2019
|
||||||
|
|
||||||
Author: Antonin Portelli <antonin.portelli@me.com>
|
Author: Antonin Portelli <antonin.portelli@me.com>
|
||||||
Author: Peter Boyle <paboyle@ph.ed.ac.uk>
|
Author: Peter Boyle <paboyle@ph.ed.ac.uk>
|
||||||
|
@ -4,7 +4,7 @@ Grid physics library, www.github.com/paboyle/Grid
|
|||||||
|
|
||||||
Source file: Hadrons/A2AVectors.hpp
|
Source file: Hadrons/A2AVectors.hpp
|
||||||
|
|
||||||
Copyright (C) 2015-2018
|
Copyright (C) 2015-2019
|
||||||
|
|
||||||
Author: Antonin Portelli <antonin.portelli@me.com>
|
Author: Antonin Portelli <antonin.portelli@me.com>
|
||||||
Author: fionnoh <fionnoh@gmail.com>
|
Author: fionnoh <fionnoh@gmail.com>
|
||||||
|
@ -4,7 +4,7 @@ Grid physics library, www.github.com/paboyle/Grid
|
|||||||
|
|
||||||
Source file: Hadrons/Application.cc
|
Source file: Hadrons/Application.cc
|
||||||
|
|
||||||
Copyright (C) 2015-2018
|
Copyright (C) 2015-2019
|
||||||
|
|
||||||
Author: Antonin Portelli <antonin.portelli@me.com>
|
Author: Antonin Portelli <antonin.portelli@me.com>
|
||||||
|
|
||||||
@ -48,28 +48,32 @@ Application::Application(void)
|
|||||||
{
|
{
|
||||||
initLogger();
|
initLogger();
|
||||||
auto dim = GridDefaultLatt(), mpi = GridDefaultMpi(), loc(dim);
|
auto dim = GridDefaultLatt(), mpi = GridDefaultMpi(), loc(dim);
|
||||||
locVol_ = 1;
|
|
||||||
for (unsigned int d = 0; d < dim.size(); ++d)
|
if (dim.size())
|
||||||
{
|
{
|
||||||
loc[d] /= mpi[d];
|
locVol_ = 1;
|
||||||
locVol_ *= loc[d];
|
for (unsigned int d = 0; d < dim.size(); ++d)
|
||||||
|
{
|
||||||
|
loc[d] /= mpi[d];
|
||||||
|
locVol_ *= loc[d];
|
||||||
|
}
|
||||||
|
LOG(Message) << "====== HADRONS APPLICATION INITIALISATION ======" << std::endl;
|
||||||
|
LOG(Message) << "** Dimensions" << std::endl;
|
||||||
|
LOG(Message) << "Global lattice: " << dim << std::endl;
|
||||||
|
LOG(Message) << "MPI partition : " << mpi << std::endl;
|
||||||
|
LOG(Message) << "Local lattice : " << loc << std::endl;
|
||||||
|
LOG(Message) << std::endl;
|
||||||
|
LOG(Message) << "** Default parameters (and associated C macros)" << std::endl;
|
||||||
|
LOG(Message) << "ASCII output precision : " << MACOUT(DEFAULT_ASCII_PREC) << std::endl;
|
||||||
|
LOG(Message) << "Fermion implementation : " << MACOUTS(FIMPLBASE) << std::endl;
|
||||||
|
LOG(Message) << "z-Fermion implementation: " << MACOUTS(ZFIMPLBASE) << std::endl;
|
||||||
|
LOG(Message) << "Scalar implementation : " << MACOUTS(SIMPLBASE) << std::endl;
|
||||||
|
LOG(Message) << "Gauge implementation : " << MACOUTS(GIMPLBASE) << std::endl;
|
||||||
|
LOG(Message) << "Eigenvector base size : "
|
||||||
|
<< MACOUT(HADRONS_DEFAULT_LANCZOS_NBASIS) << std::endl;
|
||||||
|
LOG(Message) << "Schur decomposition : " << MACOUTS(HADRONS_DEFAULT_SCHUR) << std::endl;
|
||||||
|
LOG(Message) << std::endl;
|
||||||
}
|
}
|
||||||
LOG(Message) << "====== HADRONS APPLICATION INITIALISATION ======" << std::endl;
|
|
||||||
LOG(Message) << "** Dimensions" << std::endl;
|
|
||||||
LOG(Message) << "Global lattice: " << dim << std::endl;
|
|
||||||
LOG(Message) << "MPI partition : " << mpi << std::endl;
|
|
||||||
LOG(Message) << "Local lattice : " << loc << std::endl;
|
|
||||||
LOG(Message) << std::endl;
|
|
||||||
LOG(Message) << "** Default parameters (and associated C macros)" << std::endl;
|
|
||||||
LOG(Message) << "ASCII output precision : " << MACOUT(DEFAULT_ASCII_PREC) << std::endl;
|
|
||||||
LOG(Message) << "Fermion implementation : " << MACOUTS(FIMPLBASE) << std::endl;
|
|
||||||
LOG(Message) << "z-Fermion implementation: " << MACOUTS(ZFIMPLBASE) << std::endl;
|
|
||||||
LOG(Message) << "Scalar implementation : " << MACOUTS(SIMPLBASE) << std::endl;
|
|
||||||
LOG(Message) << "Gauge implementation : " << MACOUTS(GIMPLBASE) << std::endl;
|
|
||||||
LOG(Message) << "Eigenvector base size : "
|
|
||||||
<< MACOUT(HADRONS_DEFAULT_LANCZOS_NBASIS) << std::endl;
|
|
||||||
LOG(Message) << "Schur decomposition : " << MACOUTS(HADRONS_DEFAULT_SCHUR) << std::endl;
|
|
||||||
LOG(Message) << std::endl;
|
|
||||||
}
|
}
|
||||||
|
|
||||||
Application::Application(const Application::GlobalPar &par)
|
Application::Application(const Application::GlobalPar &par)
|
||||||
|
@ -4,7 +4,7 @@ Grid physics library, www.github.com/paboyle/Grid
|
|||||||
|
|
||||||
Source file: Hadrons/Application.hpp
|
Source file: Hadrons/Application.hpp
|
||||||
|
|
||||||
Copyright (C) 2015-2018
|
Copyright (C) 2015-2019
|
||||||
|
|
||||||
Author: Antonin Portelli <antonin.portelli@me.com>
|
Author: Antonin Portelli <antonin.portelli@me.com>
|
||||||
|
|
||||||
|
@ -2,9 +2,9 @@
|
|||||||
|
|
||||||
Grid physics library, www.github.com/paboyle/Grid
|
Grid physics library, www.github.com/paboyle/Grid
|
||||||
|
|
||||||
Source file: Hadrons/Modules/MScalar/ScalarVP.cc
|
Source file: Hadrons/Archive/Modules/ScalarVP.cc
|
||||||
|
|
||||||
Copyright (C) 2015-2018
|
Copyright (C) 2015-2019
|
||||||
|
|
||||||
Author: Antonin Portelli <antonin.portelli@me.com>
|
Author: Antonin Portelli <antonin.portelli@me.com>
|
||||||
Author: James Harrison <jch1g10@soton.ac.uk>
|
Author: James Harrison <jch1g10@soton.ac.uk>
|
@ -2,9 +2,9 @@
|
|||||||
|
|
||||||
Grid physics library, www.github.com/paboyle/Grid
|
Grid physics library, www.github.com/paboyle/Grid
|
||||||
|
|
||||||
Source file: Hadrons/Modules/MScalar/ScalarVP.hpp
|
Source file: Hadrons/Archive/Modules/ScalarVP.hpp
|
||||||
|
|
||||||
Copyright (C) 2015-2018
|
Copyright (C) 2015-2019
|
||||||
|
|
||||||
Author: Antonin Portelli <antonin.portelli@me.com>
|
Author: Antonin Portelli <antonin.portelli@me.com>
|
||||||
Author: James Harrison <jch1g10@soton.ac.uk>
|
Author: James Harrison <jch1g10@soton.ac.uk>
|
@ -2,9 +2,9 @@
|
|||||||
|
|
||||||
Grid physics library, www.github.com/paboyle/Grid
|
Grid physics library, www.github.com/paboyle/Grid
|
||||||
|
|
||||||
Source file: Hadrons/Modules/MUtilities/TestSeqConserved.cc
|
Source file: Hadrons/Archive/Modules/TestSeqConserved.cc
|
||||||
|
|
||||||
Copyright (C) 2015-2018
|
Copyright (C) 2015-2019
|
||||||
|
|
||||||
Author: Antonin Portelli <antonin.portelli@me.com>
|
Author: Antonin Portelli <antonin.portelli@me.com>
|
||||||
|
|
@ -2,9 +2,9 @@
|
|||||||
|
|
||||||
Grid physics library, www.github.com/paboyle/Grid
|
Grid physics library, www.github.com/paboyle/Grid
|
||||||
|
|
||||||
Source file: Hadrons/Modules/MUtilities/TestSeqConserved.hpp
|
Source file: Hadrons/Archive/Modules/TestSeqConserved.hpp
|
||||||
|
|
||||||
Copyright (C) 2015-2018
|
Copyright (C) 2015-2019
|
||||||
|
|
||||||
Author: Antonin Portelli <antonin.portelli@me.com>
|
Author: Antonin Portelli <antonin.portelli@me.com>
|
||||||
Author: Lanny91 <andrew.lawson@gmail.com>
|
Author: Lanny91 <andrew.lawson@gmail.com>
|
@ -2,9 +2,9 @@
|
|||||||
|
|
||||||
Grid physics library, www.github.com/paboyle/Grid
|
Grid physics library, www.github.com/paboyle/Grid
|
||||||
|
|
||||||
Source file: Hadrons/Modules/MUtilities/TestSeqGamma.cc
|
Source file: Hadrons/Archive/Modules/TestSeqGamma.cc
|
||||||
|
|
||||||
Copyright (C) 2015-2018
|
Copyright (C) 2015-2019
|
||||||
|
|
||||||
Author: Antonin Portelli <antonin.portelli@me.com>
|
Author: Antonin Portelli <antonin.portelli@me.com>
|
||||||
|
|
@ -2,9 +2,9 @@
|
|||||||
|
|
||||||
Grid physics library, www.github.com/paboyle/Grid
|
Grid physics library, www.github.com/paboyle/Grid
|
||||||
|
|
||||||
Source file: Hadrons/Modules/MUtilities/TestSeqGamma.hpp
|
Source file: Hadrons/Archive/Modules/TestSeqGamma.hpp
|
||||||
|
|
||||||
Copyright (C) 2015-2018
|
Copyright (C) 2015-2019
|
||||||
|
|
||||||
Author: Antonin Portelli <antonin.portelli@me.com>
|
Author: Antonin Portelli <antonin.portelli@me.com>
|
||||||
Author: Lanny91 <andrew.lawson@gmail.com>
|
Author: Lanny91 <andrew.lawson@gmail.com>
|
@ -2,9 +2,9 @@
|
|||||||
|
|
||||||
Grid physics library, www.github.com/paboyle/Grid
|
Grid physics library, www.github.com/paboyle/Grid
|
||||||
|
|
||||||
Source file: Hadrons/Modules/MScalar/VPCounterTerms.cc
|
Source file: Hadrons/Archive/Modules/VPCounterTerms.cc
|
||||||
|
|
||||||
Copyright (C) 2015-2018
|
Copyright (C) 2015-2019
|
||||||
|
|
||||||
Author: Antonin Portelli <antonin.portelli@me.com>
|
Author: Antonin Portelli <antonin.portelli@me.com>
|
||||||
Author: James Harrison <jch1g10@soton.ac.uk>
|
Author: James Harrison <jch1g10@soton.ac.uk>
|
@ -2,9 +2,9 @@
|
|||||||
|
|
||||||
Grid physics library, www.github.com/paboyle/Grid
|
Grid physics library, www.github.com/paboyle/Grid
|
||||||
|
|
||||||
Source file: Hadrons/Modules/MScalar/VPCounterTerms.hpp
|
Source file: Hadrons/Archive/Modules/VPCounterTerms.hpp
|
||||||
|
|
||||||
Copyright (C) 2015-2018
|
Copyright (C) 2015-2019
|
||||||
|
|
||||||
Author: Antonin Portelli <antonin.portelli@me.com>
|
Author: Antonin Portelli <antonin.portelli@me.com>
|
||||||
Author: James Harrison <jch1g10@soton.ac.uk>
|
Author: James Harrison <jch1g10@soton.ac.uk>
|
@ -2,9 +2,9 @@
|
|||||||
|
|
||||||
Grid physics library, www.github.com/paboyle/Grid
|
Grid physics library, www.github.com/paboyle/Grid
|
||||||
|
|
||||||
Source file: Hadrons/Modules/MContraction/WardIdentity.cc
|
Source file: Hadrons/Archive/Modules/WardIdentity.cc
|
||||||
|
|
||||||
Copyright (C) 2015-2018
|
Copyright (C) 2015-2019
|
||||||
|
|
||||||
Author: Antonin Portelli <antonin.portelli@me.com>
|
Author: Antonin Portelli <antonin.portelli@me.com>
|
||||||
|
|
@ -2,9 +2,9 @@
|
|||||||
|
|
||||||
Grid physics library, www.github.com/paboyle/Grid
|
Grid physics library, www.github.com/paboyle/Grid
|
||||||
|
|
||||||
Source file: Hadrons/Modules/MContraction/WardIdentity.hpp
|
Source file: Hadrons/Archive/Modules/WardIdentity.hpp
|
||||||
|
|
||||||
Copyright (C) 2015-2018
|
Copyright (C) 2015-2019
|
||||||
|
|
||||||
Author: Antonin Portelli <antonin.portelli@me.com>
|
Author: Antonin Portelli <antonin.portelli@me.com>
|
||||||
Author: Lanny91 <andrew.lawson@gmail.com>
|
Author: Lanny91 <andrew.lawson@gmail.com>
|
@ -2,9 +2,9 @@
|
|||||||
|
|
||||||
Grid physics library, www.github.com/paboyle/Grid
|
Grid physics library, www.github.com/paboyle/Grid
|
||||||
|
|
||||||
Source file: Hadrons/Modules/MContraction/WeakHamiltonian.hpp
|
Source file: Hadrons/Archive/Modules/WeakHamiltonian.hpp
|
||||||
|
|
||||||
Copyright (C) 2015-2018
|
Copyright (C) 2015-2019
|
||||||
|
|
||||||
Author: Antonin Portelli <antonin.portelli@me.com>
|
Author: Antonin Portelli <antonin.portelli@me.com>
|
||||||
Author: Lanny91 <andrew.lawson@gmail.com>
|
Author: Lanny91 <andrew.lawson@gmail.com>
|
@ -2,9 +2,9 @@
|
|||||||
|
|
||||||
Grid physics library, www.github.com/paboyle/Grid
|
Grid physics library, www.github.com/paboyle/Grid
|
||||||
|
|
||||||
Source file: Hadrons/Modules/MContraction/WeakHamiltonianEye.cc
|
Source file: Hadrons/Archive/Modules/WeakHamiltonianEye.cc
|
||||||
|
|
||||||
Copyright (C) 2015-2018
|
Copyright (C) 2015-2019
|
||||||
|
|
||||||
Author: Antonin Portelli <antonin.portelli@me.com>
|
Author: Antonin Portelli <antonin.portelli@me.com>
|
||||||
Author: Lanny91 <andrew.lawson@gmail.com>
|
Author: Lanny91 <andrew.lawson@gmail.com>
|
@ -2,9 +2,9 @@
|
|||||||
|
|
||||||
Grid physics library, www.github.com/paboyle/Grid
|
Grid physics library, www.github.com/paboyle/Grid
|
||||||
|
|
||||||
Source file: Hadrons/Modules/MContraction/WeakHamiltonianEye.hpp
|
Source file: Hadrons/Archive/Modules/WeakHamiltonianEye.hpp
|
||||||
|
|
||||||
Copyright (C) 2015-2018
|
Copyright (C) 2015-2019
|
||||||
|
|
||||||
Author: Antonin Portelli <antonin.portelli@me.com>
|
Author: Antonin Portelli <antonin.portelli@me.com>
|
||||||
Author: Lanny91 <andrew.lawson@gmail.com>
|
Author: Lanny91 <andrew.lawson@gmail.com>
|
@ -2,9 +2,9 @@
|
|||||||
|
|
||||||
Grid physics library, www.github.com/paboyle/Grid
|
Grid physics library, www.github.com/paboyle/Grid
|
||||||
|
|
||||||
Source file: Hadrons/Modules/MContraction/WeakHamiltonianNonEye.cc
|
Source file: Hadrons/Archive/Modules/WeakHamiltonianNonEye.cc
|
||||||
|
|
||||||
Copyright (C) 2015-2018
|
Copyright (C) 2015-2019
|
||||||
|
|
||||||
Author: Antonin Portelli <antonin.portelli@me.com>
|
Author: Antonin Portelli <antonin.portelli@me.com>
|
||||||
Author: Lanny91 <andrew.lawson@gmail.com>
|
Author: Lanny91 <andrew.lawson@gmail.com>
|
@ -2,9 +2,9 @@
|
|||||||
|
|
||||||
Grid physics library, www.github.com/paboyle/Grid
|
Grid physics library, www.github.com/paboyle/Grid
|
||||||
|
|
||||||
Source file: Hadrons/Modules/MContraction/WeakHamiltonianNonEye.hpp
|
Source file: Hadrons/Archive/Modules/WeakHamiltonianNonEye.hpp
|
||||||
|
|
||||||
Copyright (C) 2015-2018
|
Copyright (C) 2015-2019
|
||||||
|
|
||||||
Author: Antonin Portelli <antonin.portelli@me.com>
|
Author: Antonin Portelli <antonin.portelli@me.com>
|
||||||
Author: Lanny91 <andrew.lawson@gmail.com>
|
Author: Lanny91 <andrew.lawson@gmail.com>
|
@ -2,9 +2,9 @@
|
|||||||
|
|
||||||
Grid physics library, www.github.com/paboyle/Grid
|
Grid physics library, www.github.com/paboyle/Grid
|
||||||
|
|
||||||
Source file: Hadrons/Modules/MContraction/WeakNeutral4ptDisc.cc
|
Source file: Hadrons/Archive/Modules/WeakNeutral4ptDisc.cc
|
||||||
|
|
||||||
Copyright (C) 2015-2018
|
Copyright (C) 2015-2019
|
||||||
|
|
||||||
Author: Antonin Portelli <antonin.portelli@me.com>
|
Author: Antonin Portelli <antonin.portelli@me.com>
|
||||||
Author: Lanny91 <andrew.lawson@gmail.com>
|
Author: Lanny91 <andrew.lawson@gmail.com>
|
@ -2,9 +2,9 @@
|
|||||||
|
|
||||||
Grid physics library, www.github.com/paboyle/Grid
|
Grid physics library, www.github.com/paboyle/Grid
|
||||||
|
|
||||||
Source file: Hadrons/Modules/MContraction/WeakNeutral4ptDisc.hpp
|
Source file: Hadrons/Archive/Modules/WeakNeutral4ptDisc.hpp
|
||||||
|
|
||||||
Copyright (C) 2015-2018
|
Copyright (C) 2015-2019
|
||||||
|
|
||||||
Author: Antonin Portelli <antonin.portelli@me.com>
|
Author: Antonin Portelli <antonin.portelli@me.com>
|
||||||
Author: Lanny91 <andrew.lawson@gmail.com>
|
Author: Lanny91 <andrew.lawson@gmail.com>
|
@ -4,10 +4,11 @@ Grid physics library, www.github.com/paboyle/Grid
|
|||||||
|
|
||||||
Source file: Hadrons/DilutedNoise.hpp
|
Source file: Hadrons/DilutedNoise.hpp
|
||||||
|
|
||||||
Copyright (C) 2015-2018
|
Copyright (C) 2015-2019
|
||||||
|
|
||||||
Author: Antonin Portelli <antonin.portelli@me.com>
|
Author: Antonin Portelli <antonin.portelli@me.com>
|
||||||
Author: Vera Guelpers <Vera.Guelpers@ed.ac.uk>
|
Author: Vera Guelpers <Vera.Guelpers@ed.ac.uk>
|
||||||
|
Author: Vera Guelpers <vmg1n14@soton.ac.uk>
|
||||||
|
|
||||||
This program is free software; you can redistribute it and/or modify
|
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
|
it under the terms of the GNU General Public License as published by
|
||||||
|
@ -4,7 +4,7 @@ Grid physics library, www.github.com/paboyle/Grid
|
|||||||
|
|
||||||
Source file: Hadrons/DiskVector.hpp
|
Source file: Hadrons/DiskVector.hpp
|
||||||
|
|
||||||
Copyright (C) 2015-2018
|
Copyright (C) 2015-2019
|
||||||
|
|
||||||
Author: Antonin Portelli <antonin.portelli@me.com>
|
Author: Antonin Portelli <antonin.portelli@me.com>
|
||||||
|
|
||||||
|
@ -4,7 +4,7 @@ Grid physics library, www.github.com/paboyle/Grid
|
|||||||
|
|
||||||
Source file: Hadrons/EigenPack.hpp
|
Source file: Hadrons/EigenPack.hpp
|
||||||
|
|
||||||
Copyright (C) 2015-2018
|
Copyright (C) 2015-2019
|
||||||
|
|
||||||
Author: Antonin Portelli <antonin.portelli@me.com>
|
Author: Antonin Portelli <antonin.portelli@me.com>
|
||||||
|
|
||||||
@ -308,7 +308,9 @@ template <typename FineF, typename CoarseF,
|
|||||||
class CoarseEigenPack: public EigenPack<FineF, FineFIo>
|
class CoarseEigenPack: public EigenPack<FineF, FineFIo>
|
||||||
{
|
{
|
||||||
public:
|
public:
|
||||||
typedef CoarseF CoarseField;
|
typedef CoarseF CoarseField;
|
||||||
|
typedef CoarseFIo CoarseFieldIo;
|
||||||
|
public:
|
||||||
std::vector<CoarseF> evecCoarse;
|
std::vector<CoarseF> evecCoarse;
|
||||||
std::vector<RealD> evalCoarse;
|
std::vector<RealD> evalCoarse;
|
||||||
public:
|
public:
|
||||||
|
@ -4,7 +4,7 @@ Grid physics library, www.github.com/paboyle/Grid
|
|||||||
|
|
||||||
Source file: Hadrons/Environment.cc
|
Source file: Hadrons/Environment.cc
|
||||||
|
|
||||||
Copyright (C) 2015-2018
|
Copyright (C) 2015-2019
|
||||||
|
|
||||||
Author: Antonin Portelli <antonin.portelli@me.com>
|
Author: Antonin Portelli <antonin.portelli@me.com>
|
||||||
|
|
||||||
@ -43,15 +43,13 @@ HADRONS_ERROR_REF(ObjectDefinition, "no object with address " + std::to_string(a
|
|||||||
// constructor /////////////////////////////////////////////////////////////////
|
// constructor /////////////////////////////////////////////////////////////////
|
||||||
Environment::Environment(void)
|
Environment::Environment(void)
|
||||||
{
|
{
|
||||||
dim_ = GridDefaultLatt();
|
dim_ = GridDefaultLatt();
|
||||||
nd_ = dim_.size();
|
nd_ = dim_.size();
|
||||||
createGrid<vComplex>(1);
|
|
||||||
vol_ = 1.;
|
vol_ = 1.;
|
||||||
for (auto d: dim_)
|
for (auto d: dim_)
|
||||||
{
|
{
|
||||||
vol_ *= d;
|
vol_ *= d;
|
||||||
}
|
}
|
||||||
rng4d_.reset(new GridParallelRNG(getGrid()));
|
|
||||||
}
|
}
|
||||||
|
|
||||||
// grids ///////////////////////////////////////////////////////////////////////
|
// grids ///////////////////////////////////////////////////////////////////////
|
||||||
@ -76,8 +74,13 @@ double Environment::getVolume(void) const
|
|||||||
}
|
}
|
||||||
|
|
||||||
// random number generator /////////////////////////////////////////////////////
|
// random number generator /////////////////////////////////////////////////////
|
||||||
GridParallelRNG * Environment::get4dRng(void) const
|
GridParallelRNG * Environment::get4dRng(void)
|
||||||
{
|
{
|
||||||
|
if (rng4d_ == nullptr)
|
||||||
|
{
|
||||||
|
rng4d_.reset(new GridParallelRNG(getGrid()));
|
||||||
|
}
|
||||||
|
|
||||||
return rng4d_.get();
|
return rng4d_.get();
|
||||||
}
|
}
|
||||||
|
|
||||||
|
@ -4,7 +4,7 @@ Grid physics library, www.github.com/paboyle/Grid
|
|||||||
|
|
||||||
Source file: Hadrons/Environment.hpp
|
Source file: Hadrons/Environment.hpp
|
||||||
|
|
||||||
Copyright (C) 2015-2018
|
Copyright (C) 2015-2019
|
||||||
|
|
||||||
Author: Antonin Portelli <antonin.portelli@me.com>
|
Author: Antonin Portelli <antonin.portelli@me.com>
|
||||||
|
|
||||||
@ -113,7 +113,7 @@ public:
|
|||||||
unsigned int getNd(void) const;
|
unsigned int getNd(void) const;
|
||||||
double getVolume(void) const;
|
double getVolume(void) const;
|
||||||
// random number generator
|
// random number generator
|
||||||
GridParallelRNG * get4dRng(void) const;
|
GridParallelRNG * get4dRng(void);
|
||||||
// general memory management
|
// general memory management
|
||||||
void addObject(const std::string name,
|
void addObject(const std::string name,
|
||||||
const int moduleAddress = -1);
|
const int moduleAddress = -1);
|
||||||
@ -182,7 +182,7 @@ private:
|
|||||||
std::map<CoarseGridKey, GridPt> gridCoarse5d_;
|
std::map<CoarseGridKey, GridPt> gridCoarse5d_;
|
||||||
unsigned int nd_;
|
unsigned int nd_;
|
||||||
// random number generator
|
// random number generator
|
||||||
RngPt rng4d_;
|
RngPt rng4d_{nullptr};
|
||||||
// object store
|
// object store
|
||||||
std::vector<ObjInfo> object_;
|
std::vector<ObjInfo> object_;
|
||||||
std::map<std::string, unsigned int> objectAddress_;
|
std::map<std::string, unsigned int> objectAddress_;
|
||||||
|
@ -4,7 +4,7 @@ Grid physics library, www.github.com/paboyle/Grid
|
|||||||
|
|
||||||
Source file: Hadrons/Exceptions.cc
|
Source file: Hadrons/Exceptions.cc
|
||||||
|
|
||||||
Copyright (C) 2015-2018
|
Copyright (C) 2015-2019
|
||||||
|
|
||||||
Author: Antonin Portelli <antonin.portelli@me.com>
|
Author: Antonin Portelli <antonin.portelli@me.com>
|
||||||
|
|
||||||
|
@ -4,7 +4,7 @@ Grid physics library, www.github.com/paboyle/Grid
|
|||||||
|
|
||||||
Source file: Hadrons/Exceptions.hpp
|
Source file: Hadrons/Exceptions.hpp
|
||||||
|
|
||||||
Copyright (C) 2015-2018
|
Copyright (C) 2015-2019
|
||||||
|
|
||||||
Author: Antonin Portelli <antonin.portelli@me.com>
|
Author: Antonin Portelli <antonin.portelli@me.com>
|
||||||
|
|
||||||
|
@ -4,7 +4,7 @@ Grid physics library, www.github.com/paboyle/Grid
|
|||||||
|
|
||||||
Source file: Hadrons/Factory.hpp
|
Source file: Hadrons/Factory.hpp
|
||||||
|
|
||||||
Copyright (C) 2015-2018
|
Copyright (C) 2015-2019
|
||||||
|
|
||||||
Author: Antonin Portelli <antonin.portelli@me.com>
|
Author: Antonin Portelli <antonin.portelli@me.com>
|
||||||
|
|
||||||
|
@ -4,7 +4,7 @@ Grid physics library, www.github.com/paboyle/Grid
|
|||||||
|
|
||||||
Source file: Hadrons/GeneticScheduler.hpp
|
Source file: Hadrons/GeneticScheduler.hpp
|
||||||
|
|
||||||
Copyright (C) 2015-2018
|
Copyright (C) 2015-2019
|
||||||
|
|
||||||
Author: Antonin Portelli <antonin.portelli@me.com>
|
Author: Antonin Portelli <antonin.portelli@me.com>
|
||||||
|
|
||||||
|
@ -4,7 +4,7 @@ Grid physics library, www.github.com/paboyle/Grid
|
|||||||
|
|
||||||
Source file: Hadrons/Global.cc
|
Source file: Hadrons/Global.cc
|
||||||
|
|
||||||
Copyright (C) 2015-2018
|
Copyright (C) 2015-2019
|
||||||
|
|
||||||
Author: Antonin Portelli <antonin.portelli@me.com>
|
Author: Antonin Portelli <antonin.portelli@me.com>
|
||||||
|
|
||||||
|
@ -4,7 +4,7 @@ Grid physics library, www.github.com/paboyle/Grid
|
|||||||
|
|
||||||
Source file: Hadrons/Global.hpp
|
Source file: Hadrons/Global.hpp
|
||||||
|
|
||||||
Copyright (C) 2015-2018
|
Copyright (C) 2015-2019
|
||||||
|
|
||||||
Author: Antonin Portelli <antonin.portelli@me.com>
|
Author: Antonin Portelli <antonin.portelli@me.com>
|
||||||
Author: Lanny91 <andrew.lawson@gmail.com>
|
Author: Lanny91 <andrew.lawson@gmail.com>
|
||||||
@ -44,6 +44,8 @@ See the full license in the file "LICENSE" in the top level distribution directo
|
|||||||
#define DEFAULT_ASCII_PREC 16
|
#define DEFAULT_ASCII_PREC 16
|
||||||
#endif
|
#endif
|
||||||
|
|
||||||
|
#define ARG(...) __VA_ARGS__
|
||||||
|
|
||||||
/* the 'using Grid::operator<<;' statement prevents a very nasty compilation
|
/* the 'using Grid::operator<<;' statement prevents a very nasty compilation
|
||||||
* error with GCC 5 (clang & GCC 6 compile fine without it).
|
* error with GCC 5 (clang & GCC 6 compile fine without it).
|
||||||
*/
|
*/
|
||||||
@ -101,15 +103,16 @@ BEGIN_HADRONS_NAMESPACE
|
|||||||
typedef typename Impl::Field ScalarField##suffix;\
|
typedef typename Impl::Field ScalarField##suffix;\
|
||||||
typedef typename Impl::PropagatorField PropagatorField##suffix;\
|
typedef typename Impl::PropagatorField PropagatorField##suffix;\
|
||||||
typedef typename Impl::SitePropagator::scalar_object SitePropagator##suffix;\
|
typedef typename Impl::SitePropagator::scalar_object SitePropagator##suffix;\
|
||||||
typedef std::vector<SitePropagator##suffix> SlicedPropagator##suffix;
|
typedef typename Impl::ComplexField ComplexField##suffix;\
|
||||||
|
typedef std::vector<SitePropagator##suffix> SlicedPropagator##suffix;\
|
||||||
|
typedef std::vector<typename ComplexField##suffix::vector_object::scalar_object> SlicedComplex##suffix;
|
||||||
|
|
||||||
#define FERM_TYPE_ALIASES(FImpl, suffix)\
|
#define FERM_TYPE_ALIASES(FImpl, suffix)\
|
||||||
BASIC_TYPE_ALIASES(FImpl, suffix);\
|
BASIC_TYPE_ALIASES(FImpl, suffix);\
|
||||||
typedef FermionOperator<FImpl> FMat##suffix;\
|
typedef FermionOperator<FImpl> FMat##suffix;\
|
||||||
typedef typename FImpl::FermionField FermionField##suffix;\
|
typedef typename FImpl::FermionField FermionField##suffix;\
|
||||||
typedef typename FImpl::GaugeField GaugeField##suffix;\
|
typedef typename FImpl::GaugeField GaugeField##suffix;\
|
||||||
typedef typename FImpl::DoubledGaugeField DoubledGaugeField##suffix;\
|
typedef typename FImpl::DoubledGaugeField DoubledGaugeField##suffix;
|
||||||
typedef typename FImpl::ComplexField ComplexField##suffix;
|
|
||||||
|
|
||||||
#define GAUGE_TYPE_ALIASES(GImpl, suffix)\
|
#define GAUGE_TYPE_ALIASES(GImpl, suffix)\
|
||||||
typedef typename GImpl::GaugeField GaugeField##suffix;
|
typedef typename GImpl::GaugeField GaugeField##suffix;
|
||||||
@ -263,6 +266,15 @@ void tokenReplace(std::string &str, const std::string token,
|
|||||||
}
|
}
|
||||||
}
|
}
|
||||||
|
|
||||||
|
// generic correlator class
|
||||||
|
template <typename Metadata, typename Scalar = Complex>
|
||||||
|
struct Correlator: Serializable
|
||||||
|
{
|
||||||
|
GRID_SERIALIZABLE_CLASS_MEMBERS(ARG(Correlator<Metadata, Scalar>),
|
||||||
|
Metadata, info,
|
||||||
|
std::vector<Complex>, corr);
|
||||||
|
};
|
||||||
|
|
||||||
END_HADRONS_NAMESPACE
|
END_HADRONS_NAMESPACE
|
||||||
|
|
||||||
#include <Hadrons/Exceptions.hpp>
|
#include <Hadrons/Exceptions.hpp>
|
||||||
|
@ -4,7 +4,7 @@ Grid physics library, www.github.com/paboyle/Grid
|
|||||||
|
|
||||||
Source file: Hadrons/Graph.hpp
|
Source file: Hadrons/Graph.hpp
|
||||||
|
|
||||||
Copyright (C) 2015-2018
|
Copyright (C) 2015-2019
|
||||||
|
|
||||||
Author: Antonin Portelli <antonin.portelli@me.com>
|
Author: Antonin Portelli <antonin.portelli@me.com>
|
||||||
|
|
||||||
|
@ -4,7 +4,7 @@ Grid physics library, www.github.com/paboyle/Grid
|
|||||||
|
|
||||||
Source file: Hadrons/Module.cc
|
Source file: Hadrons/Module.cc
|
||||||
|
|
||||||
Copyright (C) 2015-2018
|
Copyright (C) 2015-2019
|
||||||
|
|
||||||
Author: Antonin Portelli <antonin.portelli@me.com>
|
Author: Antonin Portelli <antonin.portelli@me.com>
|
||||||
|
|
||||||
|
@ -4,7 +4,7 @@ Grid physics library, www.github.com/paboyle/Grid
|
|||||||
|
|
||||||
Source file: Hadrons/Module.hpp
|
Source file: Hadrons/Module.hpp
|
||||||
|
|
||||||
Copyright (C) 2015-2018
|
Copyright (C) 2015-2019
|
||||||
|
|
||||||
Author: Antonin Portelli <antonin.portelli@me.com>
|
Author: Antonin Portelli <antonin.portelli@me.com>
|
||||||
|
|
||||||
@ -65,7 +65,6 @@ static ns##mod##ModuleRegistrar ns##mod##ModuleRegistrarInstance;
|
|||||||
extern template class base;\
|
extern template class base;\
|
||||||
MODULE_REGISTER(mod, ARG(base), ns);
|
MODULE_REGISTER(mod, ARG(base), ns);
|
||||||
|
|
||||||
#define ARG(...) __VA_ARGS__
|
|
||||||
#define HADRONS_MACRO_REDIRECT_12(arg1, arg2, macro, ...) macro
|
#define HADRONS_MACRO_REDIRECT_12(arg1, arg2, macro, ...) macro
|
||||||
#define HADRONS_MACRO_REDIRECT_23(arg1, arg2, arg3, macro, ...) macro
|
#define HADRONS_MACRO_REDIRECT_23(arg1, arg2, arg3, macro, ...) macro
|
||||||
|
|
||||||
@ -78,6 +77,15 @@ env().template getGrid<typename latticeType::vector_type>(Ls)
|
|||||||
#define envGetGrid(...)\
|
#define envGetGrid(...)\
|
||||||
HADRONS_MACRO_REDIRECT_12(__VA_ARGS__, envGetGrid5, envGetGrid4)(__VA_ARGS__)
|
HADRONS_MACRO_REDIRECT_12(__VA_ARGS__, envGetGrid5, envGetGrid4)(__VA_ARGS__)
|
||||||
|
|
||||||
|
#define envGetCoarseGrid4(latticeType, blockSize)\
|
||||||
|
env().template getCoarseGrid<typename latticeType::vector_type>(blockSize)
|
||||||
|
|
||||||
|
#define envGetCoarseGrid5(latticeType, blockSize, Ls)\
|
||||||
|
env().template getCoarseGrid<typename latticeType::vector_type>(blockSize, Ls)
|
||||||
|
|
||||||
|
#define envGetCoarseGrid(...)\
|
||||||
|
HADRONS_MACRO_REDIRECT_23(__VA_ARGS__, envGetCoarseGrid5, envGetCoarseGrid4)(__VA_ARGS__)
|
||||||
|
|
||||||
#define envGetRbGrid4(latticeType)\
|
#define envGetRbGrid4(latticeType)\
|
||||||
env().template getRbGrid<typename latticeType::vector_type>()
|
env().template getRbGrid<typename latticeType::vector_type>()
|
||||||
|
|
||||||
|
@ -4,7 +4,7 @@ Grid physics library, www.github.com/paboyle/Grid
|
|||||||
|
|
||||||
Source file: Hadrons/ModuleFactory.hpp
|
Source file: Hadrons/ModuleFactory.hpp
|
||||||
|
|
||||||
Copyright (C) 2015-2018
|
Copyright (C) 2015-2019
|
||||||
|
|
||||||
Author: Antonin Portelli <antonin.portelli@me.com>
|
Author: Antonin Portelli <antonin.portelli@me.com>
|
||||||
|
|
||||||
|
@ -3,6 +3,27 @@
|
|||||||
#include <Hadrons/Modules/MUtilities/PrecisionCast.hpp>
|
#include <Hadrons/Modules/MUtilities/PrecisionCast.hpp>
|
||||||
#include <Hadrons/Modules/MUtilities/TestSeqConserved.hpp>
|
#include <Hadrons/Modules/MUtilities/TestSeqConserved.hpp>
|
||||||
#include <Hadrons/Modules/MSolver/MixedPrecisionRBPrecCG.hpp>
|
#include <Hadrons/Modules/MSolver/MixedPrecisionRBPrecCG.hpp>
|
||||||
|
#include <Hadrons/Modules/MContraction/WeakEye3pt.hpp>
|
||||||
|
#include <Hadrons/Modules/MContraction/Baryon.hpp>
|
||||||
|
#include <Hadrons/Modules/MContraction/A2AAslashField.hpp>
|
||||||
|
#include <Hadrons/Modules/MContraction/A2ALoop.hpp>
|
||||||
|
#include <Hadrons/Modules/MContraction/A2AMesonField.hpp>
|
||||||
|
#include <Hadrons/Modules/MContraction/Meson.hpp>
|
||||||
|
#include <Hadrons/Modules/MContraction/DiscLoop.hpp>
|
||||||
|
#include <Hadrons/Modules/MContraction/Gamma3pt.hpp>
|
||||||
|
#include <Hadrons/Modules/MContraction/WeakNonEye3pt.hpp>
|
||||||
|
#include <Hadrons/Modules/MFermion/FreeProp.hpp>
|
||||||
|
#include <Hadrons/Modules/MFermion/GaugeProp.hpp>
|
||||||
|
#include <Hadrons/Modules/MSource/SeqGamma.hpp>
|
||||||
|
#include <Hadrons/Modules/MSource/Point.hpp>
|
||||||
|
#include <Hadrons/Modules/MSource/Wall.hpp>
|
||||||
|
#include <Hadrons/Modules/MSource/Z2.hpp>
|
||||||
|
#include <Hadrons/Modules/MSource/SeqConserved.hpp>
|
||||||
|
#include <Hadrons/Modules/MSource/Momentum.hpp>
|
||||||
|
#include <Hadrons/Modules/MSink/Smear.hpp>
|
||||||
|
#include <Hadrons/Modules/MSink/Point.hpp>
|
||||||
|
#include <Hadrons/Modules/MSolver/MixedPrecisionRBPrecCG.hpp>
|
||||||
|
#include <Hadrons/Modules/MSolver/LocalCoherenceLanczos.hpp>
|
||||||
#include <Hadrons/Modules/MSolver/A2AAslashVectors.hpp>
|
#include <Hadrons/Modules/MSolver/A2AAslashVectors.hpp>
|
||||||
#include <Hadrons/Modules/MSolver/Guesser.hpp>
|
#include <Hadrons/Modules/MSolver/Guesser.hpp>
|
||||||
#include <Hadrons/Modules/MSolver/LocalCoherenceLanczos.hpp>
|
#include <Hadrons/Modules/MSolver/LocalCoherenceLanczos.hpp>
|
||||||
@ -58,6 +79,33 @@
|
|||||||
#include <Hadrons/Modules/MLoop/NoiseLoop.hpp>
|
#include <Hadrons/Modules/MLoop/NoiseLoop.hpp>
|
||||||
#include <Hadrons/Modules/MScalarSUN/TransProj.hpp>
|
#include <Hadrons/Modules/MScalarSUN/TransProj.hpp>
|
||||||
#include <Hadrons/Modules/MScalarSUN/TwoPoint.hpp>
|
#include <Hadrons/Modules/MScalarSUN/TwoPoint.hpp>
|
||||||
|
#include <Hadrons/Modules/MGauge/UnitEm.hpp>
|
||||||
|
#include <Hadrons/Modules/MGauge/StoutSmearing.hpp>
|
||||||
|
#include <Hadrons/Modules/MGauge/Unit.hpp>
|
||||||
|
#include <Hadrons/Modules/MGauge/Random.hpp>
|
||||||
|
#include <Hadrons/Modules/MGauge/GaugeFix.hpp>
|
||||||
|
#include <Hadrons/Modules/MGauge/FundtoHirep.hpp>
|
||||||
|
#include <Hadrons/Modules/MGauge/StochEm.hpp>
|
||||||
|
#include <Hadrons/Modules/MGauge/Electrify.hpp>
|
||||||
|
#include <Hadrons/Modules/MNoise/TimeDilutedSpinColorDiagonal.hpp>
|
||||||
|
#include <Hadrons/Modules/MNoise/FullVolumeSpinColorDiagonal.hpp>
|
||||||
|
#include <Hadrons/Modules/MUtilities/PrecisionCast.hpp>
|
||||||
|
#include <Hadrons/Modules/MUtilities/RandomVectors.hpp>
|
||||||
|
#include <Hadrons/Modules/MScalar/FreeProp.hpp>
|
||||||
|
#include <Hadrons/Modules/MScalar/Scalar.hpp>
|
||||||
|
#include <Hadrons/Modules/MScalar/ChargedProp.hpp>
|
||||||
|
#include <Hadrons/Modules/MNPR/Bilinear.hpp>
|
||||||
|
#include <Hadrons/Modules/MNPR/Amputate.hpp>
|
||||||
|
#include <Hadrons/Modules/MNPR/FourQuark.hpp>
|
||||||
|
#include <Hadrons/Modules/MAction/DWF.hpp>
|
||||||
|
#include <Hadrons/Modules/MAction/MobiusDWF.hpp>
|
||||||
|
#include <Hadrons/Modules/MAction/Wilson.hpp>
|
||||||
|
#include <Hadrons/Modules/MAction/WilsonClover.hpp>
|
||||||
|
#include <Hadrons/Modules/MAction/ZMobiusDWF.hpp>
|
||||||
|
#include <Hadrons/Modules/MAction/ScaledDWF.hpp>
|
||||||
|
#include <Hadrons/Modules/MScalarSUN/StochFreeField.hpp>
|
||||||
|
#include <Hadrons/Modules/MScalarSUN/TwoPointNPR.hpp>
|
||||||
|
#include <Hadrons/Modules/MScalarSUN/Div.hpp>
|
||||||
#include <Hadrons/Modules/MScalarSUN/TrMag.hpp>
|
#include <Hadrons/Modules/MScalarSUN/TrMag.hpp>
|
||||||
#include <Hadrons/Modules/MScalarSUN/TrKinetic.hpp>
|
#include <Hadrons/Modules/MScalarSUN/TrKinetic.hpp>
|
||||||
#include <Hadrons/Modules/MScalarSUN/EMT.hpp>
|
#include <Hadrons/Modules/MScalarSUN/EMT.hpp>
|
||||||
|
@ -4,7 +4,7 @@ Grid physics library, www.github.com/paboyle/Grid
|
|||||||
|
|
||||||
Source file: Hadrons/Modules/MAction/DWF.cc
|
Source file: Hadrons/Modules/MAction/DWF.cc
|
||||||
|
|
||||||
Copyright (C) 2015-2018
|
Copyright (C) 2015-2019
|
||||||
|
|
||||||
Author: Antonin Portelli <antonin.portelli@me.com>
|
Author: Antonin Portelli <antonin.portelli@me.com>
|
||||||
|
|
||||||
|
@ -4,7 +4,7 @@ Grid physics library, www.github.com/paboyle/Grid
|
|||||||
|
|
||||||
Source file: Hadrons/Modules/MAction/DWF.hpp
|
Source file: Hadrons/Modules/MAction/DWF.hpp
|
||||||
|
|
||||||
Copyright (C) 2015-2018
|
Copyright (C) 2015-2019
|
||||||
|
|
||||||
Author: Antonin Portelli <antonin.portelli@me.com>
|
Author: Antonin Portelli <antonin.portelli@me.com>
|
||||||
Author: Lanny91 <andrew.lawson@gmail.com>
|
Author: Lanny91 <andrew.lawson@gmail.com>
|
||||||
@ -112,8 +112,6 @@ void TDWF<FImpl>::setup(void)
|
|||||||
<< par().mass << ", M5= " << par().M5 << " and Ls= "
|
<< par().mass << ", M5= " << par().M5 << " and Ls= "
|
||||||
<< par().Ls << " using gauge field '" << par().gauge << "'"
|
<< par().Ls << " using gauge field '" << par().gauge << "'"
|
||||||
<< std::endl;
|
<< std::endl;
|
||||||
LOG(Message) << "Fermion boundary conditions: " << par().boundary
|
|
||||||
<< std::endl;
|
|
||||||
|
|
||||||
auto &U = envGet(GaugeField, par().gauge);
|
auto &U = envGet(GaugeField, par().gauge);
|
||||||
auto &g4 = *envGetGrid(FermionField);
|
auto &g4 = *envGetGrid(FermionField);
|
||||||
@ -121,8 +119,26 @@ void TDWF<FImpl>::setup(void)
|
|||||||
auto &g5 = *envGetGrid(FermionField, par().Ls);
|
auto &g5 = *envGetGrid(FermionField, par().Ls);
|
||||||
auto &grb5 = *envGetRbGrid(FermionField, par().Ls);
|
auto &grb5 = *envGetRbGrid(FermionField, par().Ls);
|
||||||
typename DomainWallFermion<FImpl>::ImplParams implParams;
|
typename DomainWallFermion<FImpl>::ImplParams implParams;
|
||||||
implParams.boundary_phases = strToVec<Complex>(par().boundary);
|
if (!par().boundary.empty())
|
||||||
implParams.twist_n_2pi_L = strToVec<Real>(par().twist);
|
{
|
||||||
|
implParams.boundary_phases = strToVec<Complex>(par().boundary);
|
||||||
|
}
|
||||||
|
if (!par().twist.empty())
|
||||||
|
{
|
||||||
|
implParams.twist_n_2pi_L = strToVec<Real>(par().twist);
|
||||||
|
}
|
||||||
|
LOG(Message) << "Fermion boundary conditions: " << implParams.boundary_phases
|
||||||
|
<< std::endl;
|
||||||
|
LOG(Message) << "Twists: " << implParams.twist_n_2pi_L
|
||||||
|
<< std::endl;
|
||||||
|
if (implParams.boundary_phases.size() != env().getNd())
|
||||||
|
{
|
||||||
|
HADRONS_ERROR(Size, "Wrong number of boundary phase");
|
||||||
|
}
|
||||||
|
if (implParams.twist_n_2pi_L.size() != env().getNd())
|
||||||
|
{
|
||||||
|
HADRONS_ERROR(Size, "Wrong number of twist");
|
||||||
|
}
|
||||||
envCreateDerived(FMat, DomainWallFermion<FImpl>, getName(), par().Ls, U, g5,
|
envCreateDerived(FMat, DomainWallFermion<FImpl>, getName(), par().Ls, U, g5,
|
||||||
grb5, g4, grb4, par().mass, par().M5, implParams);
|
grb5, g4, grb4, par().mass, par().M5, implParams);
|
||||||
}
|
}
|
||||||
|
@ -4,7 +4,7 @@ Grid physics library, www.github.com/paboyle/Grid
|
|||||||
|
|
||||||
Source file: Hadrons/Modules/MAction/MobiusDWF.cc
|
Source file: Hadrons/Modules/MAction/MobiusDWF.cc
|
||||||
|
|
||||||
Copyright (C) 2015-2018
|
Copyright (C) 2015-2019
|
||||||
|
|
||||||
Author: Antonin Portelli <antonin.portelli@me.com>
|
Author: Antonin Portelli <antonin.portelli@me.com>
|
||||||
|
|
||||||
|
@ -4,7 +4,7 @@ Grid physics library, www.github.com/paboyle/Grid
|
|||||||
|
|
||||||
Source file: Hadrons/Modules/MAction/MobiusDWF.hpp
|
Source file: Hadrons/Modules/MAction/MobiusDWF.hpp
|
||||||
|
|
||||||
Copyright (C) 2015-2018
|
Copyright (C) 2015-2019
|
||||||
|
|
||||||
Author: Antonin Portelli <antonin.portelli@me.com>
|
Author: Antonin Portelli <antonin.portelli@me.com>
|
||||||
|
|
||||||
@ -112,17 +112,33 @@ void TMobiusDWF<FImpl>::setup(void)
|
|||||||
<< ", b= " << par().b << ", c= " << par().c
|
<< ", b= " << par().b << ", c= " << par().c
|
||||||
<< " using gauge field '" << par().gauge << "'"
|
<< " using gauge field '" << par().gauge << "'"
|
||||||
<< std::endl;
|
<< std::endl;
|
||||||
LOG(Message) << "Fermion boundary conditions: " << par().boundary
|
|
||||||
<< std::endl;
|
|
||||||
|
|
||||||
auto &U = envGet(GaugeField, par().gauge);
|
auto &U = envGet(GaugeField, par().gauge);
|
||||||
auto &g4 = *envGetGrid(FermionField);
|
auto &g4 = *envGetGrid(FermionField);
|
||||||
auto &grb4 = *envGetRbGrid(FermionField);
|
auto &grb4 = *envGetRbGrid(FermionField);
|
||||||
auto &g5 = *envGetGrid(FermionField, par().Ls);
|
auto &g5 = *envGetGrid(FermionField, par().Ls);
|
||||||
auto &grb5 = *envGetRbGrid(FermionField, par().Ls);
|
auto &grb5 = *envGetRbGrid(FermionField, par().Ls);
|
||||||
typename MobiusFermion<FImpl>::ImplParams implParams;
|
typename MobiusFermion<FImpl>::ImplParams implParams;
|
||||||
implParams.boundary_phases = strToVec<Complex>(par().boundary);
|
if (!par().boundary.empty())
|
||||||
implParams.twist_n_2pi_L = strToVec<Real>(par().twist);
|
{
|
||||||
|
implParams.boundary_phases = strToVec<Complex>(par().boundary);
|
||||||
|
}
|
||||||
|
if (!par().twist.empty())
|
||||||
|
{
|
||||||
|
implParams.twist_n_2pi_L = strToVec<Real>(par().twist);
|
||||||
|
}
|
||||||
|
LOG(Message) << "Fermion boundary conditions: " << implParams.boundary_phases
|
||||||
|
<< std::endl;
|
||||||
|
LOG(Message) << "Twists: " << implParams.twist_n_2pi_L
|
||||||
|
<< std::endl;
|
||||||
|
if (implParams.boundary_phases.size() != env().getNd())
|
||||||
|
{
|
||||||
|
HADRONS_ERROR(Size, "Wrong number of boundary phase");
|
||||||
|
}
|
||||||
|
if (implParams.twist_n_2pi_L.size() != env().getNd())
|
||||||
|
{
|
||||||
|
HADRONS_ERROR(Size, "Wrong number of twist");
|
||||||
|
}
|
||||||
envCreateDerived(FMat, MobiusFermion<FImpl>, getName(), par().Ls, U, g5,
|
envCreateDerived(FMat, MobiusFermion<FImpl>, getName(), par().Ls, U, g5,
|
||||||
grb5, g4, grb4, par().mass, par().M5, par().b, par().c,
|
grb5, g4, grb4, par().mass, par().M5, par().b, par().c,
|
||||||
implParams);
|
implParams);
|
||||||
|
@ -4,7 +4,7 @@ Grid physics library, www.github.com/paboyle/Grid
|
|||||||
|
|
||||||
Source file: Hadrons/Modules/MAction/ScaledDWF.cc
|
Source file: Hadrons/Modules/MAction/ScaledDWF.cc
|
||||||
|
|
||||||
Copyright (C) 2015-2018
|
Copyright (C) 2015-2019
|
||||||
|
|
||||||
Author: Antonin Portelli <antonin.portelli@me.com>
|
Author: Antonin Portelli <antonin.portelli@me.com>
|
||||||
|
|
||||||
|
@ -4,7 +4,7 @@ Grid physics library, www.github.com/paboyle/Grid
|
|||||||
|
|
||||||
Source file: Hadrons/Modules/MAction/ScaledDWF.hpp
|
Source file: Hadrons/Modules/MAction/ScaledDWF.hpp
|
||||||
|
|
||||||
Copyright (C) 2015-2018
|
Copyright (C) 2015-2019
|
||||||
|
|
||||||
Author: Antonin Portelli <antonin.portelli@me.com>
|
Author: Antonin Portelli <antonin.portelli@me.com>
|
||||||
|
|
||||||
@ -111,8 +111,6 @@ void TScaledDWF<FImpl>::setup(void)
|
|||||||
<< ", scale= " << par().scale
|
<< ", scale= " << par().scale
|
||||||
<< " using gauge field '" << par().gauge << "'"
|
<< " using gauge field '" << par().gauge << "'"
|
||||||
<< std::endl;
|
<< std::endl;
|
||||||
LOG(Message) << "Fermion boundary conditions: " << par().boundary
|
|
||||||
<< std::endl;
|
|
||||||
|
|
||||||
auto &U = envGet(GaugeField, par().gauge);
|
auto &U = envGet(GaugeField, par().gauge);
|
||||||
auto &g4 = *envGetGrid(FermionField);
|
auto &g4 = *envGetGrid(FermionField);
|
||||||
@ -120,8 +118,26 @@ void TScaledDWF<FImpl>::setup(void)
|
|||||||
auto &g5 = *envGetGrid(FermionField, par().Ls);
|
auto &g5 = *envGetGrid(FermionField, par().Ls);
|
||||||
auto &grb5 = *envGetRbGrid(FermionField, par().Ls);
|
auto &grb5 = *envGetRbGrid(FermionField, par().Ls);
|
||||||
typename ScaledShamirFermion<FImpl>::ImplParams implParams;
|
typename ScaledShamirFermion<FImpl>::ImplParams implParams;
|
||||||
implParams.boundary_phases = strToVec<Complex>(par().boundary);
|
if (!par().boundary.empty())
|
||||||
implParams.twist_n_2pi_L = strToVec<Real>(par().twist);
|
{
|
||||||
|
implParams.boundary_phases = strToVec<Complex>(par().boundary);
|
||||||
|
}
|
||||||
|
if (!par().twist.empty())
|
||||||
|
{
|
||||||
|
implParams.twist_n_2pi_L = strToVec<Real>(par().twist);
|
||||||
|
}
|
||||||
|
LOG(Message) << "Fermion boundary conditions: " << implParams.boundary_phases
|
||||||
|
<< std::endl;
|
||||||
|
LOG(Message) << "Twists: " << implParams.twist_n_2pi_L
|
||||||
|
<< std::endl;
|
||||||
|
if (implParams.boundary_phases.size() != env().getNd())
|
||||||
|
{
|
||||||
|
HADRONS_ERROR(Size, "Wrong number of boundary phase");
|
||||||
|
}
|
||||||
|
if (implParams.twist_n_2pi_L.size() != env().getNd())
|
||||||
|
{
|
||||||
|
HADRONS_ERROR(Size, "Wrong number of twist");
|
||||||
|
}
|
||||||
envCreateDerived(FMat, ScaledShamirFermion<FImpl>, getName(), par().Ls, U, g5,
|
envCreateDerived(FMat, ScaledShamirFermion<FImpl>, getName(), par().Ls, U, g5,
|
||||||
grb5, g4, grb4, par().mass, par().M5, par().scale,
|
grb5, g4, grb4, par().mass, par().M5, par().scale,
|
||||||
implParams);
|
implParams);
|
||||||
|
@ -4,7 +4,7 @@ Grid physics library, www.github.com/paboyle/Grid
|
|||||||
|
|
||||||
Source file: Hadrons/Modules/MAction/Wilson.cc
|
Source file: Hadrons/Modules/MAction/Wilson.cc
|
||||||
|
|
||||||
Copyright (C) 2015-2018
|
Copyright (C) 2015-2019
|
||||||
|
|
||||||
Author: Antonin Portelli <antonin.portelli@me.com>
|
Author: Antonin Portelli <antonin.portelli@me.com>
|
||||||
|
|
||||||
|
@ -4,7 +4,7 @@ Grid physics library, www.github.com/paboyle/Grid
|
|||||||
|
|
||||||
Source file: Hadrons/Modules/MAction/Wilson.hpp
|
Source file: Hadrons/Modules/MAction/Wilson.hpp
|
||||||
|
|
||||||
Copyright (C) 2015-2018
|
Copyright (C) 2015-2019
|
||||||
|
|
||||||
Author: Antonin Portelli <antonin.portelli@me.com>
|
Author: Antonin Portelli <antonin.portelli@me.com>
|
||||||
Author: Lanny91 <andrew.lawson@gmail.com>
|
Author: Lanny91 <andrew.lawson@gmail.com>
|
||||||
@ -109,15 +109,31 @@ void TWilson<FImpl>::setup(void)
|
|||||||
{
|
{
|
||||||
LOG(Message) << "Setting up Wilson fermion matrix with m= " << par().mass
|
LOG(Message) << "Setting up Wilson fermion matrix with m= " << par().mass
|
||||||
<< " using gauge field '" << par().gauge << "'" << std::endl;
|
<< " using gauge field '" << par().gauge << "'" << std::endl;
|
||||||
LOG(Message) << "Fermion boundary conditions: " << par().boundary
|
|
||||||
<< std::endl;
|
|
||||||
|
|
||||||
auto &U = envGet(GaugeField, par().gauge);
|
auto &U = envGet(GaugeField, par().gauge);
|
||||||
auto &grid = *envGetGrid(FermionField);
|
auto &grid = *envGetGrid(FermionField);
|
||||||
auto &gridRb = *envGetRbGrid(FermionField);
|
auto &gridRb = *envGetRbGrid(FermionField);
|
||||||
typename WilsonFermion<FImpl>::ImplParams implParams;
|
typename WilsonFermion<FImpl>::ImplParams implParams;
|
||||||
implParams.boundary_phases = strToVec<Complex>(par().boundary);
|
if (!par().boundary.empty())
|
||||||
implParams.twist_n_2pi_L = strToVec<Real>(par().twist);
|
{
|
||||||
|
implParams.boundary_phases = strToVec<Complex>(par().boundary);
|
||||||
|
}
|
||||||
|
if (!par().twist.empty())
|
||||||
|
{
|
||||||
|
implParams.twist_n_2pi_L = strToVec<Real>(par().twist);
|
||||||
|
}
|
||||||
|
LOG(Message) << "Fermion boundary conditions: " << implParams.boundary_phases
|
||||||
|
<< std::endl;
|
||||||
|
LOG(Message) << "Twists: " << implParams.twist_n_2pi_L
|
||||||
|
<< std::endl;
|
||||||
|
if (implParams.boundary_phases.size() != env().getNd())
|
||||||
|
{
|
||||||
|
HADRONS_ERROR(Size, "Wrong number of boundary phase");
|
||||||
|
}
|
||||||
|
if (implParams.twist_n_2pi_L.size() != env().getNd())
|
||||||
|
{
|
||||||
|
HADRONS_ERROR(Size, "Wrong number of twist");
|
||||||
|
}
|
||||||
envCreateDerived(FMat, WilsonFermion<FImpl>, getName(), 1, U, grid, gridRb,
|
envCreateDerived(FMat, WilsonFermion<FImpl>, getName(), 1, U, grid, gridRb,
|
||||||
par().mass, implParams);
|
par().mass, implParams);
|
||||||
}
|
}
|
||||||
|
@ -4,7 +4,7 @@ Grid physics library, www.github.com/paboyle/Grid
|
|||||||
|
|
||||||
Source file: Hadrons/Modules/MAction/WilsonClover.cc
|
Source file: Hadrons/Modules/MAction/WilsonClover.cc
|
||||||
|
|
||||||
Copyright (C) 2015-2018
|
Copyright (C) 2015-2019
|
||||||
|
|
||||||
Author: Antonin Portelli <antonin.portelli@me.com>
|
Author: Antonin Portelli <antonin.portelli@me.com>
|
||||||
|
|
||||||
|
@ -4,7 +4,7 @@ Grid physics library, www.github.com/paboyle/Grid
|
|||||||
|
|
||||||
Source file: Hadrons/Modules/MAction/WilsonClover.hpp
|
Source file: Hadrons/Modules/MAction/WilsonClover.hpp
|
||||||
|
|
||||||
Copyright (C) 2015-2018
|
Copyright (C) 2015-2019
|
||||||
|
|
||||||
Author: Antonin Portelli <antonin.portelli@me.com>
|
Author: Antonin Portelli <antonin.portelli@me.com>
|
||||||
Author: Guido Cossu <guido.cossu@ed.ac.uk>
|
Author: Guido Cossu <guido.cossu@ed.ac.uk>
|
||||||
@ -112,17 +112,34 @@ void TWilsonClover<FImpl>::setup(void)
|
|||||||
{
|
{
|
||||||
LOG(Message) << "Setting up Wilson clover fermion matrix with m= " << par().mass
|
LOG(Message) << "Setting up Wilson clover fermion matrix with m= " << par().mass
|
||||||
<< " using gauge field '" << par().gauge << "'" << std::endl;
|
<< " using gauge field '" << par().gauge << "'" << std::endl;
|
||||||
LOG(Message) << "Fermion boundary conditions: " << par().boundary
|
|
||||||
<< std::endl;
|
|
||||||
LOG(Message) << "Clover term csw_r: " << par().csw_r
|
LOG(Message) << "Clover term csw_r: " << par().csw_r
|
||||||
<< " csw_t: " << par().csw_t
|
<< " csw_t: " << par().csw_t
|
||||||
<< std::endl;
|
<< std::endl;
|
||||||
|
|
||||||
auto &U = envGet(GaugeField, par().gauge);
|
auto &U = envGet(GaugeField, par().gauge);
|
||||||
auto &grid = *envGetGrid(FermionField);
|
auto &grid = *envGetGrid(FermionField);
|
||||||
auto &gridRb = *envGetRbGrid(FermionField);
|
auto &gridRb = *envGetRbGrid(FermionField);
|
||||||
typename WilsonCloverFermion<FImpl>::ImplParams implParams;
|
typename WilsonCloverFermion<FImpl>::ImplParams implParams;
|
||||||
implParams.boundary_phases = strToVec<Complex>(par().boundary);
|
if (!par().boundary.empty())
|
||||||
implParams.twist_n_2pi_L = strToVec<Real>(par().twist);
|
{
|
||||||
|
implParams.boundary_phases = strToVec<Complex>(par().boundary);
|
||||||
|
}
|
||||||
|
if (!par().twist.empty())
|
||||||
|
{
|
||||||
|
implParams.twist_n_2pi_L = strToVec<Real>(par().twist);
|
||||||
|
}
|
||||||
|
LOG(Message) << "Fermion boundary conditions: " << implParams.boundary_phases
|
||||||
|
<< std::endl;
|
||||||
|
LOG(Message) << "Twists: " << implParams.twist_n_2pi_L
|
||||||
|
<< std::endl;
|
||||||
|
if (implParams.boundary_phases.size() != env().getNd())
|
||||||
|
{
|
||||||
|
HADRONS_ERROR(Size, "Wrong number of boundary phase");
|
||||||
|
}
|
||||||
|
if (implParams.twist_n_2pi_L.size() != env().getNd())
|
||||||
|
{
|
||||||
|
HADRONS_ERROR(Size, "Wrong number of twist");
|
||||||
|
}
|
||||||
envCreateDerived(FMat, WilsonCloverFermion<FImpl>, getName(), 1, U, grid,
|
envCreateDerived(FMat, WilsonCloverFermion<FImpl>, getName(), 1, U, grid,
|
||||||
gridRb, par().mass, par().csw_r, par().csw_t,
|
gridRb, par().mass, par().csw_r, par().csw_t,
|
||||||
par().clover_anisotropy, implParams);
|
par().clover_anisotropy, implParams);
|
||||||
|
@ -4,7 +4,7 @@ Grid physics library, www.github.com/paboyle/Grid
|
|||||||
|
|
||||||
Source file: Hadrons/Modules/MAction/ZMobiusDWF.cc
|
Source file: Hadrons/Modules/MAction/ZMobiusDWF.cc
|
||||||
|
|
||||||
Copyright (C) 2015-2018
|
Copyright (C) 2015-2019
|
||||||
|
|
||||||
Author: Antonin Portelli <antonin.portelli@me.com>
|
Author: Antonin Portelli <antonin.portelli@me.com>
|
||||||
|
|
||||||
|
@ -4,7 +4,7 @@ Grid physics library, www.github.com/paboyle/Grid
|
|||||||
|
|
||||||
Source file: Hadrons/Modules/MAction/ZMobiusDWF.hpp
|
Source file: Hadrons/Modules/MAction/ZMobiusDWF.hpp
|
||||||
|
|
||||||
Copyright (C) 2015-2018
|
Copyright (C) 2015-2019
|
||||||
|
|
||||||
Author: Antonin Portelli <antonin.portelli@me.com>
|
Author: Antonin Portelli <antonin.portelli@me.com>
|
||||||
|
|
||||||
@ -118,10 +118,7 @@ void TZMobiusDWF<FImpl>::setup(void)
|
|||||||
{
|
{
|
||||||
LOG(Message) << " omega[" << i << "]= " << par().omega[i] << std::endl;
|
LOG(Message) << " omega[" << i << "]= " << par().omega[i] << std::endl;
|
||||||
}
|
}
|
||||||
LOG(Message) << "Fermion boundary conditions: " << par().boundary
|
|
||||||
<< std::endl;
|
|
||||||
|
|
||||||
env().createGrid(par().Ls);
|
|
||||||
auto &U = envGet(GaugeField, par().gauge);
|
auto &U = envGet(GaugeField, par().gauge);
|
||||||
auto &g4 = *envGetGrid(FermionField);
|
auto &g4 = *envGetGrid(FermionField);
|
||||||
auto &grb4 = *envGetRbGrid(FermionField);
|
auto &grb4 = *envGetRbGrid(FermionField);
|
||||||
@ -129,8 +126,26 @@ void TZMobiusDWF<FImpl>::setup(void)
|
|||||||
auto &grb5 = *envGetRbGrid(FermionField, par().Ls);
|
auto &grb5 = *envGetRbGrid(FermionField, par().Ls);
|
||||||
auto omega = par().omega;
|
auto omega = par().omega;
|
||||||
typename ZMobiusFermion<FImpl>::ImplParams implParams;
|
typename ZMobiusFermion<FImpl>::ImplParams implParams;
|
||||||
implParams.boundary_phases = strToVec<Complex>(par().boundary);
|
if (!par().boundary.empty())
|
||||||
implParams.twist_n_2pi_L = strToVec<Real>(par().twist);
|
{
|
||||||
|
implParams.boundary_phases = strToVec<Complex>(par().boundary);
|
||||||
|
}
|
||||||
|
if (!par().twist.empty())
|
||||||
|
{
|
||||||
|
implParams.twist_n_2pi_L = strToVec<Real>(par().twist);
|
||||||
|
}
|
||||||
|
LOG(Message) << "Fermion boundary conditions: " << implParams.boundary_phases
|
||||||
|
<< std::endl;
|
||||||
|
LOG(Message) << "Twists: " << implParams.twist_n_2pi_L
|
||||||
|
<< std::endl;
|
||||||
|
if (implParams.boundary_phases.size() != env().getNd())
|
||||||
|
{
|
||||||
|
HADRONS_ERROR(Size, "Wrong number of boundary phase");
|
||||||
|
}
|
||||||
|
if (implParams.twist_n_2pi_L.size() != env().getNd())
|
||||||
|
{
|
||||||
|
HADRONS_ERROR(Size, "Wrong number of twist");
|
||||||
|
}
|
||||||
envCreateDerived(FMat, ZMobiusFermion<FImpl>, getName(), par().Ls, U, g5,
|
envCreateDerived(FMat, ZMobiusFermion<FImpl>, getName(), par().Ls, U, g5,
|
||||||
grb5, g4, grb4, par().mass, par().M5, omega,
|
grb5, g4, grb4, par().mass, par().M5, omega,
|
||||||
par().b, par().c, implParams);
|
par().b, par().c, implParams);
|
||||||
|
@ -4,7 +4,7 @@ Grid physics library, www.github.com/paboyle/Grid
|
|||||||
|
|
||||||
Source file: Hadrons/Modules/MContraction/A2AAslashField.cc
|
Source file: Hadrons/Modules/MContraction/A2AAslashField.cc
|
||||||
|
|
||||||
Copyright (C) 2015-2018
|
Copyright (C) 2015-2019
|
||||||
|
|
||||||
Author: Antonin Portelli <antonin.portelli@me.com>
|
Author: Antonin Portelli <antonin.portelli@me.com>
|
||||||
|
|
||||||
|
@ -4,7 +4,7 @@ Grid physics library, www.github.com/paboyle/Grid
|
|||||||
|
|
||||||
Source file: Hadrons/Modules/MContraction/A2AAslashField.hpp
|
Source file: Hadrons/Modules/MContraction/A2AAslashField.hpp
|
||||||
|
|
||||||
Copyright (C) 2015-2018
|
Copyright (C) 2015-2019
|
||||||
|
|
||||||
Author: Antonin Portelli <antonin.portelli@me.com>
|
Author: Antonin Portelli <antonin.portelli@me.com>
|
||||||
|
|
||||||
|
@ -2,9 +2,9 @@
|
|||||||
|
|
||||||
Grid physics library, www.github.com/paboyle/Grid
|
Grid physics library, www.github.com/paboyle/Grid
|
||||||
|
|
||||||
Source file: Hadrons/Modules/MLoop/NoiseLoop.cc
|
Source file: Hadrons/Modules/MContraction/A2ALoop.cc
|
||||||
|
|
||||||
Copyright (C) 2015-2018
|
Copyright (C) 2015-2019
|
||||||
|
|
||||||
Author: Antonin Portelli <antonin.portelli@me.com>
|
Author: Antonin Portelli <antonin.portelli@me.com>
|
||||||
|
|
||||||
@ -25,11 +25,10 @@ with this program; if not, write to the Free Software Foundation, Inc.,
|
|||||||
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 <Hadrons/Modules/MLoop/NoiseLoop.hpp>
|
#include <Hadrons/Modules/MContraction/A2ALoop.hpp>
|
||||||
|
|
||||||
using namespace Grid;
|
using namespace Grid;
|
||||||
using namespace Hadrons;
|
using namespace Hadrons;
|
||||||
using namespace MLoop;
|
using namespace MContraction;
|
||||||
|
|
||||||
template class Grid::Hadrons::MLoop::TNoiseLoop<FIMPL>;
|
|
||||||
|
|
||||||
|
template class Grid::Hadrons::MContraction::TA2ALoop<FIMPL>;
|
@ -2,12 +2,11 @@
|
|||||||
|
|
||||||
Grid physics library, www.github.com/paboyle/Grid
|
Grid physics library, www.github.com/paboyle/Grid
|
||||||
|
|
||||||
Source file: Hadrons/Modules/MLoop/NoiseLoop.hpp
|
Source file: Hadrons/Modules/MContraction/A2ALoop.hpp
|
||||||
|
|
||||||
Copyright (C) 2015-2018
|
Copyright (C) 2015-2019
|
||||||
|
|
||||||
Author: Antonin Portelli <antonin.portelli@me.com>
|
Author: Antonin Portelli <antonin.portelli@me.com>
|
||||||
Author: Lanny91 <andrew.lawson@gmail.com>
|
|
||||||
|
|
||||||
This program is free software; you can redistribute it and/or modify
|
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
|
it under the terms of the GNU General Public License as published by
|
||||||
@ -26,9 +25,8 @@ with this program; if not, write to the Free Software Foundation, Inc.,
|
|||||||
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 Hadrons_MContraction_A2ALoop_hpp_
|
||||||
#ifndef Hadrons_MLoop_NoiseLoop_hpp_
|
#define Hadrons_MContraction_A2ALoop_hpp_
|
||||||
#define Hadrons_MLoop_NoiseLoop_hpp_
|
|
||||||
|
|
||||||
#include <Hadrons/Global.hpp>
|
#include <Hadrons/Global.hpp>
|
||||||
#include <Hadrons/Module.hpp>
|
#include <Hadrons/Module.hpp>
|
||||||
@ -36,99 +34,90 @@ See the full license in the file "LICENSE" in the top level distribution directo
|
|||||||
|
|
||||||
BEGIN_HADRONS_NAMESPACE
|
BEGIN_HADRONS_NAMESPACE
|
||||||
|
|
||||||
/*
|
|
||||||
|
|
||||||
Noise loop propagator
|
|
||||||
-----------------------------
|
|
||||||
* loop_x = q_x * adj(eta_x)
|
|
||||||
|
|
||||||
* options:
|
|
||||||
- q = Result of inversion on noise source.
|
|
||||||
- eta = noise source.
|
|
||||||
|
|
||||||
*/
|
|
||||||
|
|
||||||
|
|
||||||
/******************************************************************************
|
/******************************************************************************
|
||||||
* NoiseLoop *
|
* From closed loop from all-to-all vectors *
|
||||||
******************************************************************************/
|
******************************************************************************/
|
||||||
BEGIN_MODULE_NAMESPACE(MLoop)
|
BEGIN_MODULE_NAMESPACE(MContraction)
|
||||||
|
|
||||||
class NoiseLoopPar: Serializable
|
class A2ALoopPar: Serializable
|
||||||
{
|
{
|
||||||
public:
|
public:
|
||||||
GRID_SERIALIZABLE_CLASS_MEMBERS(NoiseLoopPar,
|
GRID_SERIALIZABLE_CLASS_MEMBERS(A2ALoopPar,
|
||||||
std::string, q,
|
std::string, left,
|
||||||
std::string, eta);
|
std::string, right);
|
||||||
};
|
};
|
||||||
|
|
||||||
template <typename FImpl>
|
template <typename FImpl>
|
||||||
class TNoiseLoop: public Module<NoiseLoopPar>
|
class TA2ALoop: public Module<A2ALoopPar>
|
||||||
{
|
{
|
||||||
public:
|
public:
|
||||||
FERM_TYPE_ALIASES(FImpl,);
|
FERM_TYPE_ALIASES(FImpl,);
|
||||||
public:
|
public:
|
||||||
// constructor
|
// constructor
|
||||||
TNoiseLoop(const std::string name);
|
TA2ALoop(const std::string name);
|
||||||
// destructor
|
// destructor
|
||||||
virtual ~TNoiseLoop(void) {};
|
virtual ~TA2ALoop(void) {};
|
||||||
// dependency relation
|
// dependency relation
|
||||||
virtual std::vector<std::string> getInput(void);
|
virtual std::vector<std::string> getInput(void);
|
||||||
virtual std::vector<std::string> getOutput(void);
|
virtual std::vector<std::string> getOutput(void);
|
||||||
protected:
|
|
||||||
// setup
|
// setup
|
||||||
virtual void setup(void);
|
virtual void setup(void);
|
||||||
// execution
|
// execution
|
||||||
virtual void execute(void);
|
virtual void execute(void);
|
||||||
};
|
};
|
||||||
|
|
||||||
MODULE_REGISTER_TMP(NoiseLoop, TNoiseLoop<FIMPL>, MLoop);
|
MODULE_REGISTER_TMP(A2ALoop, TA2ALoop<FIMPL>, MContraction);
|
||||||
|
|
||||||
/******************************************************************************
|
/******************************************************************************
|
||||||
* TNoiseLoop implementation *
|
* TA2ALoop implementation *
|
||||||
******************************************************************************/
|
******************************************************************************/
|
||||||
// constructor /////////////////////////////////////////////////////////////////
|
// constructor /////////////////////////////////////////////////////////////////
|
||||||
template <typename FImpl>
|
template <typename FImpl>
|
||||||
TNoiseLoop<FImpl>::TNoiseLoop(const std::string name)
|
TA2ALoop<FImpl>::TA2ALoop(const std::string name)
|
||||||
: Module<NoiseLoopPar>(name)
|
: Module<A2ALoopPar>(name)
|
||||||
{}
|
{}
|
||||||
|
|
||||||
// dependencies/products ///////////////////////////////////////////////////////
|
// dependencies/products ///////////////////////////////////////////////////////
|
||||||
template <typename FImpl>
|
template <typename FImpl>
|
||||||
std::vector<std::string> TNoiseLoop<FImpl>::getInput(void)
|
std::vector<std::string> TA2ALoop<FImpl>::getInput(void)
|
||||||
{
|
{
|
||||||
std::vector<std::string> in = {par().q, par().eta};
|
std::vector<std::string> in = {par().left, par().right};
|
||||||
|
|
||||||
return in;
|
return in;
|
||||||
}
|
}
|
||||||
|
|
||||||
template <typename FImpl>
|
template <typename FImpl>
|
||||||
std::vector<std::string> TNoiseLoop<FImpl>::getOutput(void)
|
std::vector<std::string> TA2ALoop<FImpl>::getOutput(void)
|
||||||
{
|
{
|
||||||
std::vector<std::string> out = {getName()};
|
std::vector<std::string> out = {};
|
||||||
|
|
||||||
return out;
|
return out;
|
||||||
}
|
}
|
||||||
|
|
||||||
// setup ///////////////////////////////////////////////////////////////////////
|
// setup ///////////////////////////////////////////////////////////////////////
|
||||||
template <typename FImpl>
|
template <typename FImpl>
|
||||||
void TNoiseLoop<FImpl>::setup(void)
|
void TA2ALoop<FImpl>::setup(void)
|
||||||
{
|
{
|
||||||
envCreateLat(PropagatorField, getName());
|
envCreateLat(PropagatorField, getName());
|
||||||
}
|
}
|
||||||
|
|
||||||
// execution ///////////////////////////////////////////////////////////////////
|
// execution ///////////////////////////////////////////////////////////////////
|
||||||
template <typename FImpl>
|
template <typename FImpl>
|
||||||
void TNoiseLoop<FImpl>::execute(void)
|
void TA2ALoop<FImpl>::execute(void)
|
||||||
{
|
{
|
||||||
auto &loop = envGet(PropagatorField, getName());
|
auto &loop = envGet(PropagatorField, getName());
|
||||||
auto &q = envGet(PropagatorField, par().q);
|
auto &left = envGet(std::vector<FermionField>, par().left);
|
||||||
auto &eta = envGet(PropagatorField, par().eta);
|
auto &right = envGet(std::vector<FermionField>, par().right);
|
||||||
loop = q*adj(eta);
|
|
||||||
|
loop = zero;
|
||||||
|
for (unsigned int i = 0; i < left.size(); ++i)
|
||||||
|
{
|
||||||
|
loop += outerProduct(adj(left[i]), right[i]);
|
||||||
|
}
|
||||||
}
|
}
|
||||||
|
|
||||||
END_MODULE_NAMESPACE
|
END_MODULE_NAMESPACE
|
||||||
|
|
||||||
END_HADRONS_NAMESPACE
|
END_HADRONS_NAMESPACE
|
||||||
|
|
||||||
#endif // Hadrons_MLoop_NoiseLoop_hpp_
|
#endif // Hadrons_MContraction_A2ALoop_hpp_
|
@ -4,7 +4,7 @@ Grid physics library, www.github.com/paboyle/Grid
|
|||||||
|
|
||||||
Source file: Hadrons/Modules/MContraction/A2AMesonField.cc
|
Source file: Hadrons/Modules/MContraction/A2AMesonField.cc
|
||||||
|
|
||||||
Copyright (C) 2015-2018
|
Copyright (C) 2015-2019
|
||||||
|
|
||||||
Author: Antonin Portelli <antonin.portelli@me.com>
|
Author: Antonin Portelli <antonin.portelli@me.com>
|
||||||
Author: paboyle <paboyle@ph.ed.ac.uk>
|
Author: paboyle <paboyle@ph.ed.ac.uk>
|
||||||
|
@ -4,7 +4,7 @@ Grid physics library, www.github.com/paboyle/Grid
|
|||||||
|
|
||||||
Source file: Hadrons/Modules/MContraction/A2AMesonField.hpp
|
Source file: Hadrons/Modules/MContraction/A2AMesonField.hpp
|
||||||
|
|
||||||
Copyright (C) 2015-2018
|
Copyright (C) 2015-2019
|
||||||
|
|
||||||
Author: Antonin Portelli <antonin.portelli@me.com>
|
Author: Antonin Portelli <antonin.portelli@me.com>
|
||||||
Author: Peter Boyle <paboyle@ph.ed.ac.uk>
|
Author: Peter Boyle <paboyle@ph.ed.ac.uk>
|
||||||
|
@ -4,7 +4,7 @@ Grid physics library, www.github.com/paboyle/Grid
|
|||||||
|
|
||||||
Source file: Hadrons/Modules/MContraction/Baryon.cc
|
Source file: Hadrons/Modules/MContraction/Baryon.cc
|
||||||
|
|
||||||
Copyright (C) 2015-2018
|
Copyright (C) 2015-2019
|
||||||
|
|
||||||
Author: Antonin Portelli <antonin.portelli@me.com>
|
Author: Antonin Portelli <antonin.portelli@me.com>
|
||||||
|
|
||||||
|
@ -4,7 +4,7 @@ Grid physics library, www.github.com/paboyle/Grid
|
|||||||
|
|
||||||
Source file: Hadrons/Modules/MContraction/Baryon.hpp
|
Source file: Hadrons/Modules/MContraction/Baryon.hpp
|
||||||
|
|
||||||
Copyright (C) 2015-2018
|
Copyright (C) 2015-2019
|
||||||
|
|
||||||
Author: Antonin Portelli <antonin.portelli@me.com>
|
Author: Antonin Portelli <antonin.portelli@me.com>
|
||||||
Author: Lanny91 <andrew.lawson@gmail.com>
|
Author: Lanny91 <andrew.lawson@gmail.com>
|
||||||
|
@ -4,7 +4,7 @@ Grid physics library, www.github.com/paboyle/Grid
|
|||||||
|
|
||||||
Source file: Hadrons/Modules/MContraction/DiscLoop.cc
|
Source file: Hadrons/Modules/MContraction/DiscLoop.cc
|
||||||
|
|
||||||
Copyright (C) 2015-2018
|
Copyright (C) 2015-2019
|
||||||
|
|
||||||
Author: Antonin Portelli <antonin.portelli@me.com>
|
Author: Antonin Portelli <antonin.portelli@me.com>
|
||||||
|
|
||||||
|
@ -4,7 +4,7 @@ Grid physics library, www.github.com/paboyle/Grid
|
|||||||
|
|
||||||
Source file: Hadrons/Modules/MContraction/DiscLoop.hpp
|
Source file: Hadrons/Modules/MContraction/DiscLoop.hpp
|
||||||
|
|
||||||
Copyright (C) 2015-2018
|
Copyright (C) 2015-2019
|
||||||
|
|
||||||
Author: Antonin Portelli <antonin.portelli@me.com>
|
Author: Antonin Portelli <antonin.portelli@me.com>
|
||||||
Author: Lanny91 <andrew.lawson@gmail.com>
|
Author: Lanny91 <andrew.lawson@gmail.com>
|
||||||
|
@ -4,7 +4,7 @@ Grid physics library, www.github.com/paboyle/Grid
|
|||||||
|
|
||||||
Source file: Hadrons/Modules/MContraction/Gamma3pt.cc
|
Source file: Hadrons/Modules/MContraction/Gamma3pt.cc
|
||||||
|
|
||||||
Copyright (C) 2015-2018
|
Copyright (C) 2015-2019
|
||||||
|
|
||||||
Author: Antonin Portelli <antonin.portelli@me.com>
|
Author: Antonin Portelli <antonin.portelli@me.com>
|
||||||
|
|
||||||
|
@ -4,7 +4,7 @@ Grid physics library, www.github.com/paboyle/Grid
|
|||||||
|
|
||||||
Source file: Hadrons/Modules/MContraction/Gamma3pt.hpp
|
Source file: Hadrons/Modules/MContraction/Gamma3pt.hpp
|
||||||
|
|
||||||
Copyright (C) 2015-2018
|
Copyright (C) 2015-2019
|
||||||
|
|
||||||
Author: Antonin Portelli <antonin.portelli@me.com>
|
Author: Antonin Portelli <antonin.portelli@me.com>
|
||||||
Author: Lanny91 <andrew.lawson@gmail.com>
|
Author: Lanny91 <andrew.lawson@gmail.com>
|
||||||
|
@ -4,7 +4,7 @@ Grid physics library, www.github.com/paboyle/Grid
|
|||||||
|
|
||||||
Source file: Hadrons/Modules/MContraction/Meson.cc
|
Source file: Hadrons/Modules/MContraction/Meson.cc
|
||||||
|
|
||||||
Copyright (C) 2015-2018
|
Copyright (C) 2015-2019
|
||||||
|
|
||||||
Author: Antonin Portelli <antonin.portelli@me.com>
|
Author: Antonin Portelli <antonin.portelli@me.com>
|
||||||
|
|
||||||
|
@ -4,7 +4,7 @@ Grid physics library, www.github.com/paboyle/Grid
|
|||||||
|
|
||||||
Source file: Hadrons/Modules/MContraction/Meson.hpp
|
Source file: Hadrons/Modules/MContraction/Meson.hpp
|
||||||
|
|
||||||
Copyright (C) 2015-2018
|
Copyright (C) 2015-2019
|
||||||
|
|
||||||
Author: Antonin Portelli <antonin.portelli@me.com>
|
Author: Antonin Portelli <antonin.portelli@me.com>
|
||||||
Author: Lanny91 <andrew.lawson@gmail.com>
|
Author: Lanny91 <andrew.lawson@gmail.com>
|
||||||
|
@ -2,9 +2,9 @@
|
|||||||
|
|
||||||
Grid physics library, www.github.com/paboyle/Grid
|
Grid physics library, www.github.com/paboyle/Grid
|
||||||
|
|
||||||
Source file: Hadrons/Modules/MScalarSUN/ShiftProbe.cc
|
Source file: Hadrons/Modules/MContraction/WeakEye3pt.cc
|
||||||
|
|
||||||
Copyright (C) 2015-2018
|
Copyright (C) 2015-2019
|
||||||
|
|
||||||
Author: Antonin Portelli <antonin.portelli@me.com>
|
Author: Antonin Portelli <antonin.portelli@me.com>
|
||||||
|
|
||||||
@ -25,15 +25,10 @@ with this program; if not, write to the Free Software Foundation, Inc.,
|
|||||||
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 <Hadrons/Modules/MScalarSUN/ShiftProbe.hpp>
|
#include <Hadrons/Modules/MContraction/WeakEye3pt.hpp>
|
||||||
|
|
||||||
using namespace Grid;
|
using namespace Grid;
|
||||||
using namespace Hadrons;
|
using namespace Hadrons;
|
||||||
using namespace MScalarSUN;
|
using namespace MContraction;
|
||||||
|
|
||||||
template class Grid::Hadrons::MScalarSUN::TShiftProbe<ScalarNxNAdjImplR<2>>;
|
|
||||||
template class Grid::Hadrons::MScalarSUN::TShiftProbe<ScalarNxNAdjImplR<3>>;
|
|
||||||
template class Grid::Hadrons::MScalarSUN::TShiftProbe<ScalarNxNAdjImplR<4>>;
|
|
||||||
template class Grid::Hadrons::MScalarSUN::TShiftProbe<ScalarNxNAdjImplR<5>>;
|
|
||||||
template class Grid::Hadrons::MScalarSUN::TShiftProbe<ScalarNxNAdjImplR<6>>;
|
|
||||||
|
|
||||||
|
template class Grid::Hadrons::MContraction::TWeakEye3pt<FIMPL>;
|
200
Hadrons/Modules/MContraction/WeakEye3pt.hpp
Normal file
200
Hadrons/Modules/MContraction/WeakEye3pt.hpp
Normal file
@ -0,0 +1,200 @@
|
|||||||
|
/*************************************************************************************
|
||||||
|
|
||||||
|
Grid physics library, www.github.com/paboyle/Grid
|
||||||
|
|
||||||
|
Source file: Hadrons/Modules/MContraction/WeakEye3pt.hpp
|
||||||
|
|
||||||
|
Copyright (C) 2015-2019
|
||||||
|
|
||||||
|
Author: Antonin Portelli <antonin.portelli@me.com>
|
||||||
|
Author: Lanny91 <andrew.lawson@gmail.com>
|
||||||
|
|
||||||
|
This program is free software; you can redistribute it and/or modify
|
||||||
|
it under the terms of the GNU General Public License as published by
|
||||||
|
the Free Software Foundation; either version 2 of the License, or
|
||||||
|
(at your option) any later version.
|
||||||
|
|
||||||
|
This program is distributed in the hope that it will be useful,
|
||||||
|
but WITHOUT ANY WARRANTY; without even the implied warranty of
|
||||||
|
MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the
|
||||||
|
GNU General Public License for more details.
|
||||||
|
|
||||||
|
You should have received a copy of the GNU General Public License along
|
||||||
|
with this program; if not, write to the Free Software Foundation, Inc.,
|
||||||
|
51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA.
|
||||||
|
|
||||||
|
See the full license in the file "LICENSE" in the top level distribution directory
|
||||||
|
*************************************************************************************/
|
||||||
|
/* END LEGAL */
|
||||||
|
#ifndef Hadrons_MContraction_WeakEye3pt_hpp_
|
||||||
|
#define Hadrons_MContraction_WeakEye3pt_hpp_
|
||||||
|
|
||||||
|
#include <Hadrons/Global.hpp>
|
||||||
|
#include <Hadrons/Module.hpp>
|
||||||
|
#include <Hadrons/ModuleFactory.hpp>
|
||||||
|
|
||||||
|
BEGIN_HADRONS_NAMESPACE
|
||||||
|
|
||||||
|
/*
|
||||||
|
* Weak Hamiltonian meson 3-pt diagrams, eye topologies.
|
||||||
|
*
|
||||||
|
* Schematics: loop |
|
||||||
|
* /-<-¬ |
|
||||||
|
* / \ | qbl G qbr
|
||||||
|
* \ / | /----<------*------<----¬
|
||||||
|
* qbl \ / qbr | / /-*-¬ \
|
||||||
|
* /-----<-----* *-----<----¬ | / / G \ \
|
||||||
|
* gIn * G G * gOut | gIn * \ / loop * gOut
|
||||||
|
* \ / | \ \->-/ /
|
||||||
|
* \ / | \ /
|
||||||
|
* \---------->---------/ | \----------->----------/
|
||||||
|
* qs | qs
|
||||||
|
* |
|
||||||
|
* one trace | two traces
|
||||||
|
*
|
||||||
|
* one trace : tr(qbr*gOut*qs*adj(gIn)*g5*adj(qbl)*g5*G*loop*G*qbr*gOut)
|
||||||
|
* two traces: tr(qbr*gOut*qs*adj(gIn)*g5*adj(qbl)*g5*G)*tr(loop*G)
|
||||||
|
*
|
||||||
|
*/
|
||||||
|
|
||||||
|
BEGIN_MODULE_NAMESPACE(MContraction)
|
||||||
|
|
||||||
|
class WeakEye3ptPar: Serializable
|
||||||
|
{
|
||||||
|
public:
|
||||||
|
GRID_SERIALIZABLE_CLASS_MEMBERS(WeakEye3ptPar,
|
||||||
|
std::string, qBarLeft,
|
||||||
|
std::string, qBarRight,
|
||||||
|
std::string, qSpectator,
|
||||||
|
std::string, loop,
|
||||||
|
unsigned int, tOut,
|
||||||
|
Gamma::Algebra, gammaIn,
|
||||||
|
Gamma::Algebra, gammaOut,
|
||||||
|
std::string, output);
|
||||||
|
};
|
||||||
|
|
||||||
|
template <typename FImpl>
|
||||||
|
class TWeakEye3pt: public Module<WeakEye3ptPar>
|
||||||
|
{
|
||||||
|
public:
|
||||||
|
FERM_TYPE_ALIASES(FImpl,);
|
||||||
|
class Metadata: Serializable
|
||||||
|
{
|
||||||
|
public:
|
||||||
|
GRID_SERIALIZABLE_CLASS_MEMBERS(Metadata,
|
||||||
|
Gamma::Algebra, in,
|
||||||
|
Gamma::Algebra, out,
|
||||||
|
Gamma::Algebra, op,
|
||||||
|
unsigned int, trace);
|
||||||
|
};
|
||||||
|
typedef Correlator<Metadata> Result;
|
||||||
|
public:
|
||||||
|
// constructor
|
||||||
|
TWeakEye3pt(const std::string name);
|
||||||
|
// destructor
|
||||||
|
virtual ~TWeakEye3pt(void) {};
|
||||||
|
// dependency relation
|
||||||
|
virtual std::vector<std::string> getInput(void);
|
||||||
|
virtual std::vector<std::string> getOutput(void);
|
||||||
|
// setup
|
||||||
|
virtual void setup(void);
|
||||||
|
// execution
|
||||||
|
virtual void execute(void);
|
||||||
|
};
|
||||||
|
|
||||||
|
MODULE_REGISTER_TMP(WeakEye3pt, TWeakEye3pt<FIMPL>, MContraction);
|
||||||
|
|
||||||
|
/******************************************************************************
|
||||||
|
* TWeakEye3pt implementation *
|
||||||
|
******************************************************************************/
|
||||||
|
// constructor /////////////////////////////////////////////////////////////////
|
||||||
|
template <typename FImpl>
|
||||||
|
TWeakEye3pt<FImpl>::TWeakEye3pt(const std::string name)
|
||||||
|
: Module<WeakEye3ptPar>(name)
|
||||||
|
{}
|
||||||
|
|
||||||
|
// dependencies/products ///////////////////////////////////////////////////////
|
||||||
|
template <typename FImpl>
|
||||||
|
std::vector<std::string> TWeakEye3pt<FImpl>::getInput(void)
|
||||||
|
{
|
||||||
|
std::vector<std::string> in = {par().qBarLeft, par().qBarRight,
|
||||||
|
par().qSpectator};
|
||||||
|
|
||||||
|
return in;
|
||||||
|
}
|
||||||
|
|
||||||
|
template <typename FImpl>
|
||||||
|
std::vector<std::string> TWeakEye3pt<FImpl>::getOutput(void)
|
||||||
|
{
|
||||||
|
std::vector<std::string> out = {};
|
||||||
|
|
||||||
|
return out;
|
||||||
|
}
|
||||||
|
|
||||||
|
// setup ///////////////////////////////////////////////////////////////////////
|
||||||
|
template <typename FImpl>
|
||||||
|
void TWeakEye3pt<FImpl>::setup(void)
|
||||||
|
{
|
||||||
|
envTmpLat(ComplexField, "corr");
|
||||||
|
}
|
||||||
|
|
||||||
|
// execution ///////////////////////////////////////////////////////////////////
|
||||||
|
template <typename FImpl>
|
||||||
|
void TWeakEye3pt<FImpl>::execute(void)
|
||||||
|
{
|
||||||
|
LOG(Message) << "Computing mesonic weak 3pt contractions, eye topologies" << std::endl;
|
||||||
|
LOG(Message) << "gIn : " << par().gammaIn << std::endl;
|
||||||
|
LOG(Message) << "gOut: " << par().gammaIn << std::endl;
|
||||||
|
LOG(Message) << "tOut: " << par().tOut << std::endl;
|
||||||
|
LOG(Message) << "qbl : " << par().qBarLeft << std::endl;
|
||||||
|
LOG(Message) << "qbr : " << par().qBarRight << std::endl;
|
||||||
|
LOG(Message) << "qs : " << par().qSpectator << std::endl;
|
||||||
|
LOG(Message) << "loop: " << par().loop << std::endl;
|
||||||
|
|
||||||
|
std::vector<Result> result;
|
||||||
|
Result r;
|
||||||
|
auto &qbl = envGet(PropagatorField, par().qBarLeft);
|
||||||
|
auto &qbr = envGet(PropagatorField, par().qBarRight);
|
||||||
|
auto &loop = envGet(PropagatorField, par().loop);
|
||||||
|
auto &qs = envGet(SlicedPropagator, par().qSpectator);
|
||||||
|
auto qst = qs[par().tOut];
|
||||||
|
Gamma gIn(par().gammaIn), gOut(par().gammaOut);
|
||||||
|
Gamma g5(Gamma::Algebra::Gamma5);
|
||||||
|
|
||||||
|
envGetTmp(ComplexField, corr);
|
||||||
|
r.info.in = par().gammaIn;
|
||||||
|
r.info.out = par().gammaOut;
|
||||||
|
for (auto &G: Gamma::gall)
|
||||||
|
{
|
||||||
|
SlicedComplex buf;
|
||||||
|
|
||||||
|
r.info.op = G.g;
|
||||||
|
// one trace
|
||||||
|
corr = trace(qbr*gOut*qst*adj(gIn)*g5*adj(qbl)*g5*G*loop*G*qbr*gOut);
|
||||||
|
sliceSum(corr, buf, Tp);
|
||||||
|
r.corr.clear();
|
||||||
|
for (unsigned int t = 0; t < buf.size(); ++t)
|
||||||
|
{
|
||||||
|
r.corr.push_back(TensorRemove(buf[t]));
|
||||||
|
}
|
||||||
|
r.info.trace = 1;
|
||||||
|
result.push_back(r);
|
||||||
|
// two traces
|
||||||
|
corr = trace(qbr*gOut*qst*adj(gIn)*g5*adj(qbl)*g5*G)*trace(loop*G);
|
||||||
|
sliceSum(corr, buf, Tp);
|
||||||
|
r.corr.clear();
|
||||||
|
for (unsigned int t = 0; t < buf.size(); ++t)
|
||||||
|
{
|
||||||
|
r.corr.push_back(TensorRemove(buf[t]));
|
||||||
|
}
|
||||||
|
r.info.trace = 2;
|
||||||
|
result.push_back(r);
|
||||||
|
}
|
||||||
|
saveResult(par().output, "weakEye3pt", result);
|
||||||
|
}
|
||||||
|
|
||||||
|
END_MODULE_NAMESPACE
|
||||||
|
|
||||||
|
END_HADRONS_NAMESPACE
|
||||||
|
|
||||||
|
#endif // Hadrons_MContraction_WeakEye3pt_hpp_
|
34
Hadrons/Modules/MContraction/WeakNonEye3pt.cc
Normal file
34
Hadrons/Modules/MContraction/WeakNonEye3pt.cc
Normal file
@ -0,0 +1,34 @@
|
|||||||
|
/*************************************************************************************
|
||||||
|
|
||||||
|
Grid physics library, www.github.com/paboyle/Grid
|
||||||
|
|
||||||
|
Source file: Hadrons/Modules/MContraction/WeakNonEye3pt.cc
|
||||||
|
|
||||||
|
Copyright (C) 2015-2019
|
||||||
|
|
||||||
|
Author: Antonin Portelli <antonin.portelli@me.com>
|
||||||
|
|
||||||
|
This program is free software; you can redistribute it and/or modify
|
||||||
|
it under the terms of the GNU General Public License as published by
|
||||||
|
the Free Software Foundation; either version 2 of the License, or
|
||||||
|
(at your option) any later version.
|
||||||
|
|
||||||
|
This program is distributed in the hope that it will be useful,
|
||||||
|
but WITHOUT ANY WARRANTY; without even the implied warranty of
|
||||||
|
MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the
|
||||||
|
GNU General Public License for more details.
|
||||||
|
|
||||||
|
You should have received a copy of the GNU General Public License along
|
||||||
|
with this program; if not, write to the Free Software Foundation, Inc.,
|
||||||
|
51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA.
|
||||||
|
|
||||||
|
See the full license in the file "LICENSE" in the top level distribution directory
|
||||||
|
*************************************************************************************/
|
||||||
|
/* END LEGAL */
|
||||||
|
#include <Hadrons/Modules/MContraction/WeakNonEye3pt.hpp>
|
||||||
|
|
||||||
|
using namespace Grid;
|
||||||
|
using namespace Hadrons;
|
||||||
|
using namespace MContraction;
|
||||||
|
|
||||||
|
template class Grid::Hadrons::MContraction::TWeakNonEye3pt<FIMPL>;
|
198
Hadrons/Modules/MContraction/WeakNonEye3pt.hpp
Normal file
198
Hadrons/Modules/MContraction/WeakNonEye3pt.hpp
Normal file
@ -0,0 +1,198 @@
|
|||||||
|
/*************************************************************************************
|
||||||
|
|
||||||
|
Grid physics library, www.github.com/paboyle/Grid
|
||||||
|
|
||||||
|
Source file: Hadrons/Modules/MContraction/WeakNonEye3pt.hpp
|
||||||
|
|
||||||
|
Copyright (C) 2015-2019
|
||||||
|
|
||||||
|
Author: Antonin Portelli <antonin.portelli@me.com>
|
||||||
|
Author: Lanny91 <andrew.lawson@gmail.com>
|
||||||
|
|
||||||
|
This program is free software; you can redistribute it and/or modify
|
||||||
|
it under the terms of the GNU General Public License as published by
|
||||||
|
the Free Software Foundation; either version 2 of the License, or
|
||||||
|
(at your option) any later version.
|
||||||
|
|
||||||
|
This program is distributed in the hope that it will be useful,
|
||||||
|
but WITHOUT ANY WARRANTY; without even the implied warranty of
|
||||||
|
MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the
|
||||||
|
GNU General Public License for more details.
|
||||||
|
|
||||||
|
You should have received a copy of the GNU General Public License along
|
||||||
|
with this program; if not, write to the Free Software Foundation, Inc.,
|
||||||
|
51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA.
|
||||||
|
|
||||||
|
See the full license in the file "LICENSE" in the top level distribution directory
|
||||||
|
*************************************************************************************/
|
||||||
|
/* END LEGAL */
|
||||||
|
#ifndef Hadrons_MContraction_WeakNonEye3pt_hpp_
|
||||||
|
#define Hadrons_MContraction_WeakNonEye3pt_hpp_
|
||||||
|
|
||||||
|
#include <Hadrons/Global.hpp>
|
||||||
|
#include <Hadrons/Module.hpp>
|
||||||
|
#include <Hadrons/ModuleFactory.hpp>
|
||||||
|
|
||||||
|
BEGIN_HADRONS_NAMESPACE
|
||||||
|
|
||||||
|
/*
|
||||||
|
* Weak Hamiltonian meson 3-pt diagrams, non-eye topologies.
|
||||||
|
*
|
||||||
|
* Schematic:
|
||||||
|
* qbl qbr | qbl qbr
|
||||||
|
* /--<--¬ /--<--¬ | /--<--¬ /--<--¬
|
||||||
|
* / \ / \ | / \ / \
|
||||||
|
* / \ / \ | / \ / \
|
||||||
|
* / \ / \ | / \ / \
|
||||||
|
* gIn * * G * gOut | gIn * G * * G * gOut
|
||||||
|
* \ * G | | \ / \ /
|
||||||
|
* \ / \ / | \ / \ /
|
||||||
|
* \ / \ / | \ / \ /
|
||||||
|
* \ / \ / | \-->--/ \-->--/
|
||||||
|
* \-->--/ \-->--/ | ql qr
|
||||||
|
* ql qr |
|
||||||
|
* one trace | two traces
|
||||||
|
*
|
||||||
|
* one trace : tr(ql*adj(gIn)*g5*adj(qbl)*g5*G*qbr*gOut*g5*adj(qr)*g5*G)
|
||||||
|
* two traces: tr(ql*adj(gIn)*g5*adj(qbl)*g5*G)*tr(qbr*gOut*g5*adj(qr)*g5*G)
|
||||||
|
*
|
||||||
|
*/
|
||||||
|
|
||||||
|
BEGIN_MODULE_NAMESPACE(MContraction)
|
||||||
|
|
||||||
|
class WeakNonEye3ptPar: Serializable
|
||||||
|
{
|
||||||
|
public:
|
||||||
|
GRID_SERIALIZABLE_CLASS_MEMBERS(WeakNonEye3ptPar,
|
||||||
|
std::string, qLeft,
|
||||||
|
std::string, qBarLeft,
|
||||||
|
std::string, qRight,
|
||||||
|
std::string, qBarRight,
|
||||||
|
Gamma::Algebra, gammaIn,
|
||||||
|
Gamma::Algebra, gammaOut,
|
||||||
|
std::string, output);
|
||||||
|
};
|
||||||
|
|
||||||
|
template <typename FImpl>
|
||||||
|
class TWeakNonEye3pt: public Module<WeakNonEye3ptPar>
|
||||||
|
{
|
||||||
|
public:
|
||||||
|
FERM_TYPE_ALIASES(FImpl,);
|
||||||
|
class Metadata: Serializable
|
||||||
|
{
|
||||||
|
public:
|
||||||
|
GRID_SERIALIZABLE_CLASS_MEMBERS(Metadata,
|
||||||
|
Gamma::Algebra, in,
|
||||||
|
Gamma::Algebra, out,
|
||||||
|
Gamma::Algebra, op,
|
||||||
|
unsigned int, trace);
|
||||||
|
};
|
||||||
|
typedef Correlator<Metadata> Result;
|
||||||
|
public:
|
||||||
|
// constructor
|
||||||
|
TWeakNonEye3pt(const std::string name);
|
||||||
|
// destructor
|
||||||
|
virtual ~TWeakNonEye3pt(void) {};
|
||||||
|
// dependency relation
|
||||||
|
virtual std::vector<std::string> getInput(void);
|
||||||
|
virtual std::vector<std::string> getOutput(void);
|
||||||
|
// setup
|
||||||
|
virtual void setup(void);
|
||||||
|
// execution
|
||||||
|
virtual void execute(void);
|
||||||
|
};
|
||||||
|
|
||||||
|
MODULE_REGISTER_TMP(WeakNonEye3pt, TWeakNonEye3pt<FIMPL>, MContraction);
|
||||||
|
|
||||||
|
/******************************************************************************
|
||||||
|
* TWeakNonEye3pt implementation *
|
||||||
|
******************************************************************************/
|
||||||
|
// constructor /////////////////////////////////////////////////////////////////
|
||||||
|
template <typename FImpl>
|
||||||
|
TWeakNonEye3pt<FImpl>::TWeakNonEye3pt(const std::string name)
|
||||||
|
: Module<WeakNonEye3ptPar>(name)
|
||||||
|
{}
|
||||||
|
|
||||||
|
// dependencies/products ///////////////////////////////////////////////////////
|
||||||
|
template <typename FImpl>
|
||||||
|
std::vector<std::string> TWeakNonEye3pt<FImpl>::getInput(void)
|
||||||
|
{
|
||||||
|
std::vector<std::string> in = {par().qLeft, par().qBarLeft,
|
||||||
|
par().qRight, par().qBarRight};
|
||||||
|
|
||||||
|
return in;
|
||||||
|
}
|
||||||
|
|
||||||
|
template <typename FImpl>
|
||||||
|
std::vector<std::string> TWeakNonEye3pt<FImpl>::getOutput(void)
|
||||||
|
{
|
||||||
|
std::vector<std::string> out = {};
|
||||||
|
|
||||||
|
return out;
|
||||||
|
}
|
||||||
|
|
||||||
|
// setup ///////////////////////////////////////////////////////////////////////
|
||||||
|
template <typename FImpl>
|
||||||
|
void TWeakNonEye3pt<FImpl>::setup(void)
|
||||||
|
{
|
||||||
|
envTmpLat(ComplexField, "corr");
|
||||||
|
}
|
||||||
|
|
||||||
|
// execution ///////////////////////////////////////////////////////////////////
|
||||||
|
template <typename FImpl>
|
||||||
|
void TWeakNonEye3pt<FImpl>::execute(void)
|
||||||
|
{
|
||||||
|
LOG(Message) << "Computing mesonic weak 3pt contractions, non-eye topologies" << std::endl;
|
||||||
|
LOG(Message) << "gIn : " << par().gammaIn << std::endl;
|
||||||
|
LOG(Message) << "gOut: " << par().gammaIn << std::endl;
|
||||||
|
LOG(Message) << "ql : " << par().qLeft << std::endl;
|
||||||
|
LOG(Message) << "qbl : " << par().qBarLeft << std::endl;
|
||||||
|
LOG(Message) << "qr : " << par().qRight << std::endl;
|
||||||
|
LOG(Message) << "qbr : " << par().qBarRight << std::endl;
|
||||||
|
|
||||||
|
std::vector<Result> result;
|
||||||
|
Result r;
|
||||||
|
auto &ql = envGet(PropagatorField, par().qLeft);
|
||||||
|
auto &qbl = envGet(PropagatorField, par().qBarLeft);
|
||||||
|
auto &qr = envGet(PropagatorField, par().qRight);
|
||||||
|
auto &qbr = envGet(PropagatorField, par().qBarRight);
|
||||||
|
Gamma gIn(par().gammaIn), gOut(par().gammaOut);
|
||||||
|
Gamma g5(Gamma::Algebra::Gamma5);
|
||||||
|
|
||||||
|
envGetTmp(ComplexField, corr);
|
||||||
|
r.info.in = par().gammaIn;
|
||||||
|
r.info.out = par().gammaOut;
|
||||||
|
for (auto &G: Gamma::gall)
|
||||||
|
{
|
||||||
|
SlicedComplex buf;
|
||||||
|
|
||||||
|
r.info.op = G.g;
|
||||||
|
// one trace
|
||||||
|
corr = trace(ql*adj(gIn)*g5*adj(qbl)*g5*G*qbr*gOut*g5*adj(qr)*g5*G);
|
||||||
|
sliceSum(corr, buf, Tp);
|
||||||
|
r.corr.clear();
|
||||||
|
for (unsigned int t = 0; t < buf.size(); ++t)
|
||||||
|
{
|
||||||
|
r.corr.push_back(TensorRemove(buf[t]));
|
||||||
|
}
|
||||||
|
r.info.trace = 1;
|
||||||
|
result.push_back(r);
|
||||||
|
// two traces
|
||||||
|
corr = trace(ql*adj(gIn)*g5*adj(qbl)*g5*G)*trace(qbr*gOut*g5*adj(qr)*g5*G);
|
||||||
|
sliceSum(corr, buf, Tp);
|
||||||
|
r.corr.clear();
|
||||||
|
for (unsigned int t = 0; t < buf.size(); ++t)
|
||||||
|
{
|
||||||
|
r.corr.push_back(TensorRemove(buf[t]));
|
||||||
|
}
|
||||||
|
r.info.trace = 2;
|
||||||
|
result.push_back(r);
|
||||||
|
}
|
||||||
|
saveResult(par().output, "weakNonEye3pt", result);
|
||||||
|
}
|
||||||
|
|
||||||
|
END_MODULE_NAMESPACE
|
||||||
|
|
||||||
|
END_HADRONS_NAMESPACE
|
||||||
|
|
||||||
|
#endif // Hadrons_MContraction_WeakNonEye3pt_hpp_
|
@ -4,7 +4,7 @@ Grid physics library, www.github.com/paboyle/Grid
|
|||||||
|
|
||||||
Source file: Hadrons/Modules/MFermion/FreeProp.cc
|
Source file: Hadrons/Modules/MFermion/FreeProp.cc
|
||||||
|
|
||||||
Copyright (C) 2015-2018
|
Copyright (C) 2015-2019
|
||||||
|
|
||||||
Author: Antonin Portelli <antonin.portelli@me.com>
|
Author: Antonin Portelli <antonin.portelli@me.com>
|
||||||
Author: Vera Guelpers <vmg1n14@soton.ac.uk>
|
Author: Vera Guelpers <vmg1n14@soton.ac.uk>
|
||||||
|
@ -4,7 +4,7 @@ Grid physics library, www.github.com/paboyle/Grid
|
|||||||
|
|
||||||
Source file: Hadrons/Modules/MFermion/FreeProp.hpp
|
Source file: Hadrons/Modules/MFermion/FreeProp.hpp
|
||||||
|
|
||||||
Copyright (C) 2015-2018
|
Copyright (C) 2015-2019
|
||||||
|
|
||||||
Author: Antonin Portelli <antonin.portelli@me.com>
|
Author: Antonin Portelli <antonin.portelli@me.com>
|
||||||
Author: Vera Guelpers <vmg1n14@soton.ac.uk>
|
Author: Vera Guelpers <vmg1n14@soton.ac.uk>
|
||||||
|
@ -4,7 +4,7 @@ Grid physics library, www.github.com/paboyle/Grid
|
|||||||
|
|
||||||
Source file: Hadrons/Modules/MFermion/GaugeProp.cc
|
Source file: Hadrons/Modules/MFermion/GaugeProp.cc
|
||||||
|
|
||||||
Copyright (C) 2015-2018
|
Copyright (C) 2015-2019
|
||||||
|
|
||||||
Author: Antonin Portelli <antonin.portelli@me.com>
|
Author: Antonin Portelli <antonin.portelli@me.com>
|
||||||
|
|
||||||
|
@ -4,7 +4,7 @@ Grid physics library, www.github.com/paboyle/Grid
|
|||||||
|
|
||||||
Source file: Hadrons/Modules/MFermion/GaugeProp.hpp
|
Source file: Hadrons/Modules/MFermion/GaugeProp.hpp
|
||||||
|
|
||||||
Copyright (C) 2015-2018
|
Copyright (C) 2015-2019
|
||||||
|
|
||||||
Author: Antonin Portelli <antonin.portelli@me.com>
|
Author: Antonin Portelli <antonin.portelli@me.com>
|
||||||
Author: Guido Cossu <guido.cossu@ed.ac.uk>
|
Author: Guido Cossu <guido.cossu@ed.ac.uk>
|
||||||
|
@ -4,9 +4,11 @@ Grid physics library, www.github.com/paboyle/Grid
|
|||||||
|
|
||||||
Source file: Hadrons/Modules/MGauge/Electrify.cc
|
Source file: Hadrons/Modules/MGauge/Electrify.cc
|
||||||
|
|
||||||
Copyright (C) 2015-2018
|
Copyright (C) 2015-2019
|
||||||
|
|
||||||
|
Author: Antonin Portelli <antonin.portelli@me.com>
|
||||||
Author: Vera Guelpers <Vera.Guelpers@ed.ac.uk>
|
Author: Vera Guelpers <Vera.Guelpers@ed.ac.uk>
|
||||||
|
Author: Vera Guelpers <vmg1n14@soton.ac.uk>
|
||||||
|
|
||||||
This program is free software; you can redistribute it and/or modify
|
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
|
it under the terms of the GNU General Public License as published by
|
||||||
|
@ -4,9 +4,11 @@ Grid physics library, www.github.com/paboyle/Grid
|
|||||||
|
|
||||||
Source file: Hadrons/Modules/MGauge/Electrify.hpp
|
Source file: Hadrons/Modules/MGauge/Electrify.hpp
|
||||||
|
|
||||||
Copyright (C) 2015-2018
|
Copyright (C) 2015-2019
|
||||||
|
|
||||||
|
Author: Antonin Portelli <antonin.portelli@me.com>
|
||||||
Author: Vera Guelpers <Vera.Guelpers@ed.ac.uk>
|
Author: Vera Guelpers <Vera.Guelpers@ed.ac.uk>
|
||||||
|
Author: Vera Guelpers <vmg1n14@soton.ac.uk>
|
||||||
|
|
||||||
This program is free software; you can redistribute it and/or modify
|
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
|
it under the terms of the GNU General Public License as published by
|
||||||
|
@ -4,7 +4,7 @@ Grid physics library, www.github.com/paboyle/Grid
|
|||||||
|
|
||||||
Source file: Hadrons/Modules/MGauge/FundtoHirep.cc
|
Source file: Hadrons/Modules/MGauge/FundtoHirep.cc
|
||||||
|
|
||||||
Copyright (C) 2015-2018
|
Copyright (C) 2015-2019
|
||||||
|
|
||||||
Author: Antonin Portelli <antonin.portelli@me.com>
|
Author: Antonin Portelli <antonin.portelli@me.com>
|
||||||
Author: Guido Cossu <guido.cossu@ed.ac.uk>
|
Author: Guido Cossu <guido.cossu@ed.ac.uk>
|
||||||
|
@ -4,7 +4,7 @@ Grid physics library, www.github.com/paboyle/Grid
|
|||||||
|
|
||||||
Source file: Hadrons/Modules/MGauge/FundtoHirep.hpp
|
Source file: Hadrons/Modules/MGauge/FundtoHirep.hpp
|
||||||
|
|
||||||
Copyright (C) 2015-2018
|
Copyright (C) 2015-2019
|
||||||
|
|
||||||
Author: Antonin Portelli <antonin.portelli@me.com>
|
Author: Antonin Portelli <antonin.portelli@me.com>
|
||||||
Author: pretidav <david.preti@csic.es>
|
Author: pretidav <david.preti@csic.es>
|
||||||
|
@ -4,7 +4,7 @@ Grid physics library, www.github.com/paboyle/Grid
|
|||||||
|
|
||||||
Source file: Hadrons/Modules/MGauge/GaugeFix.cc
|
Source file: Hadrons/Modules/MGauge/GaugeFix.cc
|
||||||
|
|
||||||
Copyright (C) 2015-2018
|
Copyright (C) 2015-2019
|
||||||
|
|
||||||
Author: Antonin Portelli <antonin.portelli@me.com>
|
Author: Antonin Portelli <antonin.portelli@me.com>
|
||||||
Author: Peter Boyle <paboyle@ph.ed.ac.uk>
|
Author: Peter Boyle <paboyle@ph.ed.ac.uk>
|
||||||
|
@ -4,7 +4,7 @@ Grid physics library, www.github.com/paboyle/Grid
|
|||||||
|
|
||||||
Source file: Hadrons/Modules/MGauge/GaugeFix.hpp
|
Source file: Hadrons/Modules/MGauge/GaugeFix.hpp
|
||||||
|
|
||||||
Copyright (C) 2015-2018
|
Copyright (C) 2015-2019
|
||||||
|
|
||||||
Author: Antonin Portelli <antonin.portelli@me.com>
|
Author: Antonin Portelli <antonin.portelli@me.com>
|
||||||
Author: Peter Boyle <paboyle@ph.ed.ac.uk>
|
Author: Peter Boyle <paboyle@ph.ed.ac.uk>
|
||||||
|
@ -4,7 +4,7 @@ Grid physics library, www.github.com/paboyle/Grid
|
|||||||
|
|
||||||
Source file: Hadrons/Modules/MGauge/Random.cc
|
Source file: Hadrons/Modules/MGauge/Random.cc
|
||||||
|
|
||||||
Copyright (C) 2015-2018
|
Copyright (C) 2015-2019
|
||||||
|
|
||||||
Author: Antonin Portelli <antonin.portelli@me.com>
|
Author: Antonin Portelli <antonin.portelli@me.com>
|
||||||
|
|
||||||
|
@ -4,7 +4,7 @@ Grid physics library, www.github.com/paboyle/Grid
|
|||||||
|
|
||||||
Source file: Hadrons/Modules/MGauge/Random.hpp
|
Source file: Hadrons/Modules/MGauge/Random.hpp
|
||||||
|
|
||||||
Copyright (C) 2015-2018
|
Copyright (C) 2015-2019
|
||||||
|
|
||||||
Author: Antonin Portelli <antonin.portelli@me.com>
|
Author: Antonin Portelli <antonin.portelli@me.com>
|
||||||
|
|
||||||
|
@ -4,7 +4,7 @@ Grid physics library, www.github.com/paboyle/Grid
|
|||||||
|
|
||||||
Source file: Hadrons/Modules/MGauge/StochEm.cc
|
Source file: Hadrons/Modules/MGauge/StochEm.cc
|
||||||
|
|
||||||
Copyright (C) 2015-2018
|
Copyright (C) 2015-2019
|
||||||
|
|
||||||
Author: Antonin Portelli <antonin.portelli@me.com>
|
Author: Antonin Portelli <antonin.portelli@me.com>
|
||||||
Author: James Harrison <jch1g10@soton.ac.uk>
|
Author: James Harrison <jch1g10@soton.ac.uk>
|
||||||
|
@ -4,7 +4,7 @@ Grid physics library, www.github.com/paboyle/Grid
|
|||||||
|
|
||||||
Source file: Hadrons/Modules/MGauge/StochEm.hpp
|
Source file: Hadrons/Modules/MGauge/StochEm.hpp
|
||||||
|
|
||||||
Copyright (C) 2015-2018
|
Copyright (C) 2015-2019
|
||||||
|
|
||||||
Author: Antonin Portelli <antonin.portelli@me.com>
|
Author: Antonin Portelli <antonin.portelli@me.com>
|
||||||
Author: James Harrison <jch1g10@soton.ac.uk>
|
Author: James Harrison <jch1g10@soton.ac.uk>
|
||||||
|
@ -4,7 +4,7 @@ Grid physics library, www.github.com/paboyle/Grid
|
|||||||
|
|
||||||
Source file: Hadrons/Modules/MGauge/StoutSmearing.cc
|
Source file: Hadrons/Modules/MGauge/StoutSmearing.cc
|
||||||
|
|
||||||
Copyright (C) 2015-2018
|
Copyright (C) 2015-2019
|
||||||
|
|
||||||
Author: Antonin Portelli <antonin.portelli@me.com>
|
Author: Antonin Portelli <antonin.portelli@me.com>
|
||||||
|
|
||||||
|
@ -4,7 +4,7 @@ Grid physics library, www.github.com/paboyle/Grid
|
|||||||
|
|
||||||
Source file: Hadrons/Modules/MGauge/StoutSmearing.hpp
|
Source file: Hadrons/Modules/MGauge/StoutSmearing.hpp
|
||||||
|
|
||||||
Copyright (C) 2015-2018
|
Copyright (C) 2015-2019
|
||||||
|
|
||||||
Author: Antonin Portelli <antonin.portelli@me.com>
|
Author: Antonin Portelli <antonin.portelli@me.com>
|
||||||
|
|
||||||
|
@ -4,7 +4,7 @@ Grid physics library, www.github.com/paboyle/Grid
|
|||||||
|
|
||||||
Source file: Hadrons/Modules/MGauge/Unit.cc
|
Source file: Hadrons/Modules/MGauge/Unit.cc
|
||||||
|
|
||||||
Copyright (C) 2015-2018
|
Copyright (C) 2015-2019
|
||||||
|
|
||||||
Author: Antonin Portelli <antonin.portelli@me.com>
|
Author: Antonin Portelli <antonin.portelli@me.com>
|
||||||
|
|
||||||
|
@ -4,7 +4,7 @@ Grid physics library, www.github.com/paboyle/Grid
|
|||||||
|
|
||||||
Source file: Hadrons/Modules/MGauge/Unit.hpp
|
Source file: Hadrons/Modules/MGauge/Unit.hpp
|
||||||
|
|
||||||
Copyright (C) 2015-2018
|
Copyright (C) 2015-2019
|
||||||
|
|
||||||
Author: Antonin Portelli <antonin.portelli@me.com>
|
Author: Antonin Portelli <antonin.portelli@me.com>
|
||||||
|
|
||||||
|
@ -4,7 +4,7 @@ Grid physics library, www.github.com/paboyle/Grid
|
|||||||
|
|
||||||
Source file: Hadrons/Modules/MGauge/UnitEm.cc
|
Source file: Hadrons/Modules/MGauge/UnitEm.cc
|
||||||
|
|
||||||
Copyright (C) 2015-2018
|
Copyright (C) 2015-2019
|
||||||
|
|
||||||
Author: Antonin Portelli <antonin.portelli@me.com>
|
Author: Antonin Portelli <antonin.portelli@me.com>
|
||||||
Author: James Harrison <jch1g10@soton.ac.uk>
|
Author: James Harrison <jch1g10@soton.ac.uk>
|
||||||
|
@ -4,7 +4,7 @@ Grid physics library, www.github.com/paboyle/Grid
|
|||||||
|
|
||||||
Source file: Hadrons/Modules/MGauge/UnitEm.hpp
|
Source file: Hadrons/Modules/MGauge/UnitEm.hpp
|
||||||
|
|
||||||
Copyright (C) 2015-2018
|
Copyright (C) 2015-2019
|
||||||
|
|
||||||
Author: Antonin Portelli <antonin.portelli@me.com>
|
Author: Antonin Portelli <antonin.portelli@me.com>
|
||||||
Author: James Harrison <jch1g10@soton.ac.uk>
|
Author: James Harrison <jch1g10@soton.ac.uk>
|
||||||
|
Some files were not shown because too many files have changed in this diff Show More
Loading…
Reference in New Issue
Block a user