1
0
mirror of https://github.com/paboyle/Grid.git synced 2025-04-04 03:05:55 +01:00

GLobal edit for QCD namespace removal & NAMESPACE macros

This commit is contained in:
paboyle 2018-01-15 09:37:58 +00:00
parent ca6bdd7302
commit d74c21a386
175 changed files with 245 additions and 261 deletions

View File

@ -30,7 +30,7 @@ Author: paboyle <paboyle@ph.ed.ac.uk>
using namespace std; using namespace std;
using namespace Grid; using namespace Grid;
using namespace Grid::QCD; ;
typedef WilsonFermion5D<DomainWallVec5dImplR> WilsonFermion5DR; typedef WilsonFermion5D<DomainWallVec5dImplR> WilsonFermion5DR;
typedef WilsonFermion5D<DomainWallVec5dImplF> WilsonFermion5DF; typedef WilsonFermion5D<DomainWallVec5dImplF> WilsonFermion5DF;
@ -369,19 +369,19 @@ public:
#endif #endif
controls Cases [] = { controls Cases [] = {
#ifdef AVX512 #ifdef AVX512
{ QCD::WilsonKernelsStatic::OptInlineAsm , QCD::WilsonKernelsStatic::CommsThenCompute ,CartesianCommunicator::CommunicatorPolicySequential }, { WilsonKernelsStatic::OptInlineAsm , WilsonKernelsStatic::CommsThenCompute ,CartesianCommunicator::CommunicatorPolicySequential },
{ QCD::WilsonKernelsStatic::OptInlineAsm , QCD::WilsonKernelsStatic::CommsAndCompute ,CartesianCommunicator::CommunicatorPolicySequential }, { WilsonKernelsStatic::OptInlineAsm , WilsonKernelsStatic::CommsAndCompute ,CartesianCommunicator::CommunicatorPolicySequential },
#endif #endif
{ QCD::WilsonKernelsStatic::OptHandUnroll, QCD::WilsonKernelsStatic::CommsThenCompute ,CartesianCommunicator::CommunicatorPolicySequential }, { WilsonKernelsStatic::OptHandUnroll, WilsonKernelsStatic::CommsThenCompute ,CartesianCommunicator::CommunicatorPolicySequential },
{ QCD::WilsonKernelsStatic::OptHandUnroll, QCD::WilsonKernelsStatic::CommsAndCompute ,CartesianCommunicator::CommunicatorPolicySequential }, { WilsonKernelsStatic::OptHandUnroll, WilsonKernelsStatic::CommsAndCompute ,CartesianCommunicator::CommunicatorPolicySequential },
{ QCD::WilsonKernelsStatic::OptGeneric , QCD::WilsonKernelsStatic::CommsThenCompute ,CartesianCommunicator::CommunicatorPolicySequential }, { WilsonKernelsStatic::OptGeneric , WilsonKernelsStatic::CommsThenCompute ,CartesianCommunicator::CommunicatorPolicySequential },
{ QCD::WilsonKernelsStatic::OptGeneric , QCD::WilsonKernelsStatic::CommsAndCompute ,CartesianCommunicator::CommunicatorPolicySequential } { WilsonKernelsStatic::OptGeneric , WilsonKernelsStatic::CommsAndCompute ,CartesianCommunicator::CommunicatorPolicySequential }
}; };
for(int c=0;c<num_cases;c++) { for(int c=0;c<num_cases;c++) {
QCD::WilsonKernelsStatic::Comms = Cases[c].CommsOverlap; WilsonKernelsStatic::Comms = Cases[c].CommsOverlap;
QCD::WilsonKernelsStatic::Opt = Cases[c].Opt; WilsonKernelsStatic::Opt = Cases[c].Opt;
CartesianCommunicator::SetCommunicatorPolicy(Cases[c].CommsAsynch); CartesianCommunicator::SetCommunicatorPolicy(Cases[c].CommsAsynch);
std::cout<<GridLogMessage << "=================================================================================="<<std::endl; std::cout<<GridLogMessage << "=================================================================================="<<std::endl;
@ -577,19 +577,19 @@ public:
#endif #endif
controls Cases [] = { controls Cases [] = {
#ifdef AVX512 #ifdef AVX512
{ QCD::WilsonKernelsStatic::OptInlineAsm , QCD::WilsonKernelsStatic::CommsThenCompute ,CartesianCommunicator::CommunicatorPolicySequential }, { WilsonKernelsStatic::OptInlineAsm , WilsonKernelsStatic::CommsThenCompute ,CartesianCommunicator::CommunicatorPolicySequential },
{ QCD::WilsonKernelsStatic::OptInlineAsm , QCD::WilsonKernelsStatic::CommsAndCompute ,CartesianCommunicator::CommunicatorPolicySequential }, { WilsonKernelsStatic::OptInlineAsm , WilsonKernelsStatic::CommsAndCompute ,CartesianCommunicator::CommunicatorPolicySequential },
#endif #endif
{ QCD::WilsonKernelsStatic::OptHandUnroll, QCD::WilsonKernelsStatic::CommsThenCompute ,CartesianCommunicator::CommunicatorPolicySequential }, { WilsonKernelsStatic::OptHandUnroll, WilsonKernelsStatic::CommsThenCompute ,CartesianCommunicator::CommunicatorPolicySequential },
{ QCD::WilsonKernelsStatic::OptHandUnroll, QCD::WilsonKernelsStatic::CommsAndCompute ,CartesianCommunicator::CommunicatorPolicySequential }, { WilsonKernelsStatic::OptHandUnroll, WilsonKernelsStatic::CommsAndCompute ,CartesianCommunicator::CommunicatorPolicySequential },
{ QCD::WilsonKernelsStatic::OptGeneric , QCD::WilsonKernelsStatic::CommsThenCompute ,CartesianCommunicator::CommunicatorPolicySequential }, { WilsonKernelsStatic::OptGeneric , WilsonKernelsStatic::CommsThenCompute ,CartesianCommunicator::CommunicatorPolicySequential },
{ QCD::WilsonKernelsStatic::OptGeneric , QCD::WilsonKernelsStatic::CommsAndCompute ,CartesianCommunicator::CommunicatorPolicySequential } { WilsonKernelsStatic::OptGeneric , WilsonKernelsStatic::CommsAndCompute ,CartesianCommunicator::CommunicatorPolicySequential }
}; };
for(int c=0;c<num_cases;c++) { for(int c=0;c<num_cases;c++) {
QCD::WilsonKernelsStatic::Comms = Cases[c].CommsOverlap; WilsonKernelsStatic::Comms = Cases[c].CommsOverlap;
QCD::WilsonKernelsStatic::Opt = Cases[c].Opt; WilsonKernelsStatic::Opt = Cases[c].Opt;
CartesianCommunicator::SetCommunicatorPolicy(Cases[c].CommsAsynch); CartesianCommunicator::SetCommunicatorPolicy(Cases[c].CommsAsynch);
std::cout<<GridLogMessage << "=================================================================================="<<std::endl; std::cout<<GridLogMessage << "=================================================================================="<<std::endl;

View File

@ -29,7 +29,7 @@ Author: Peter Boyle <paboyle@ph.ed.ac.uk>
using namespace std; using namespace std;
using namespace Grid; using namespace Grid;
using namespace Grid::QCD; ;
struct time_statistics{ struct time_statistics{
double mean; double mean;

View File

@ -24,7 +24,7 @@
using namespace std; using namespace std;
using namespace Grid; using namespace Grid;
using namespace Grid::QCD; ;
template<class d> template<class d>
struct scal { struct scal {

View File

@ -30,7 +30,7 @@ Author: paboyle <paboyle@ph.ed.ac.uk>
using namespace std; using namespace std;
using namespace Grid; using namespace Grid;
using namespace Grid::QCD; ;
template<class d> template<class d>
struct scal { struct scal {

View File

@ -2,7 +2,7 @@
#include <sstream> #include <sstream>
using namespace std; using namespace std;
using namespace Grid; using namespace Grid;
using namespace Grid::QCD; ;
template<class d> template<class d>
struct scal { struct scal {

View File

@ -30,7 +30,7 @@ Author: paboyle <paboyle@ph.ed.ac.uk>
using namespace std; using namespace std;
using namespace Grid; using namespace Grid;
using namespace Grid::QCD; ;
int main (int argc, char ** argv) int main (int argc, char ** argv)
{ {

View File

@ -30,7 +30,7 @@ Author: paboyle <paboyle@ph.ed.ac.uk>
using namespace std; using namespace std;
using namespace Grid; using namespace Grid;
using namespace Grid::QCD; ;
int main (int argc, char ** argv) int main (int argc, char ** argv)
{ {

View File

@ -30,7 +30,7 @@ Author: paboyle <paboyle@ph.ed.ac.uk>
using namespace std; using namespace std;
using namespace Grid; using namespace Grid;
using namespace Grid::QCD; ;
int main (int argc, char ** argv) int main (int argc, char ** argv)

View File

@ -30,7 +30,7 @@ Author: paboyle <paboyle@ph.ed.ac.uk>
using namespace std; using namespace std;
using namespace Grid; using namespace Grid;
using namespace Grid::QCD; ;
int main (int argc, char ** argv) int main (int argc, char ** argv)
{ {

View File

@ -30,7 +30,7 @@ Author: Peter Boyle <peterboyle@Peters-MacBook-Pro-2.local>
using namespace std; using namespace std;
using namespace Grid; using namespace Grid;
using namespace Grid::QCD; ;
int main (int argc, char ** argv) int main (int argc, char ** argv)
{ {

View File

@ -30,7 +30,7 @@ Author: paboyle <paboyle@ph.ed.ac.uk>
using namespace std; using namespace std;
using namespace Grid; using namespace Grid;
using namespace Grid::QCD; ;
template<class d> template<class d>
struct scal { struct scal {

View File

@ -23,7 +23,7 @@ Author: Richard Rollins <rprollins@users.noreply.github.com>
using namespace std; using namespace std;
using namespace Grid; using namespace Grid;
using namespace Grid::QCD; ;
template<class d> template<class d>
struct scal { struct scal {

View File

@ -29,7 +29,7 @@ Author: Peter Boyle <paboyle@ph.ed.ac.uk>
using namespace std; using namespace std;
using namespace Grid; using namespace Grid;
using namespace Grid::QCD; ;
void su3_test_mult_expression(LatticeColourMatrix &z, LatticeColourMatrix &x,LatticeColourMatrix &y) void su3_test_mult_expression(LatticeColourMatrix &z, LatticeColourMatrix &x,LatticeColourMatrix &y)
{ {

View File

@ -29,7 +29,7 @@ Author: Peter Boyle <paboyle@ph.ed.ac.uk>
using namespace std; using namespace std;
using namespace Grid; using namespace Grid;
using namespace Grid::QCD; ;
void su3_test_mult_routine(LatticeColourMatrix &z, LatticeColourMatrix &x,LatticeColourMatrix &y) void su3_test_mult_routine(LatticeColourMatrix &z, LatticeColourMatrix &x,LatticeColourMatrix &y)

View File

@ -46,6 +46,7 @@ if test "${OPENMP_CXXFLAGS}X" != "X"; then
AM_CXXFLAGS="$OPENMP_CXXFLAGS $AM_CXXFLAGS" AM_CXXFLAGS="$OPENMP_CXXFLAGS $AM_CXXFLAGS"
AM_LDFLAGS="$OPENMP_CXXFLAGS $AM_LDFLAGS" AM_LDFLAGS="$OPENMP_CXXFLAGS $AM_LDFLAGS"
fi fi
ac_openmp=yes
############### Checks for header files ############### Checks for header files
AC_CHECK_HEADERS(stdint.h) AC_CHECK_HEADERS(stdint.h)

View File

@ -31,7 +31,7 @@ See the full license in the file "LICENSE" in the top level distribution directo
#include <Grid/Hadrons/GeneticScheduler.hpp> #include <Grid/Hadrons/GeneticScheduler.hpp>
using namespace Grid; using namespace Grid;
using namespace QCD;
using namespace Hadrons; using namespace Hadrons;
#define BIG_SEP "===============" #define BIG_SEP "==============="

View File

@ -32,7 +32,7 @@ See the full license in the file "LICENSE" in the top level distribution directo
#include <Grid/Hadrons/ModuleFactory.hpp> #include <Grid/Hadrons/ModuleFactory.hpp>
using namespace Grid; using namespace Grid;
using namespace QCD;
using namespace Hadrons; using namespace Hadrons;
#define ERROR_NO_ADDRESS(address)\ #define ERROR_NO_ADDRESS(address)\

View File

@ -54,4 +54,4 @@ CONST_EXC(Io, Runtime("IO error: " + msg, loc))
CONST_EXC(Memory, Runtime("memory error: " + msg, loc)) CONST_EXC(Memory, Runtime("memory error: " + msg, loc))
CONST_EXC(Parsing, Runtime("parsing error: " + msg, loc)) CONST_EXC(Parsing, Runtime("parsing error: " + msg, loc))
CONST_EXC(Program, Runtime("program error: " + msg, loc)) CONST_EXC(Program, Runtime("program error: " + msg, loc))
CONST_EXC(System, Runtime("system error: " + msg, loc)) CONST_EXC(System, Runtime("system error: " + msg, loc))

View File

@ -30,7 +30,7 @@ See the full license in the file "LICENSE" in the top level distribution directo
#include <Grid/Hadrons/Global.hpp> #include <Grid/Hadrons/Global.hpp>
using namespace Grid; using namespace Grid;
using namespace QCD;
using namespace Hadrons; using namespace Hadrons;
HadronsLogger Hadrons::HadronsLogError(1,"Error"); HadronsLogger Hadrons::HadronsLogError(1,"Error");

View File

@ -41,7 +41,7 @@ See the full license in the file "LICENSE" in the top level distribution directo
#define BEGIN_HADRONS_NAMESPACE \ #define BEGIN_HADRONS_NAMESPACE \
namespace Grid {\ namespace Grid {\
using namespace QCD;\ \
namespace Hadrons {\ namespace Hadrons {\
using Grid::operator<<; using Grid::operator<<;
#define END_HADRONS_NAMESPACE }} #define END_HADRONS_NAMESPACE }}

View File

@ -30,7 +30,7 @@ See the full license in the file "LICENSE" in the top level distribution directo
#include <Grid/Hadrons/Application.hpp> #include <Grid/Hadrons/Application.hpp>
using namespace Grid; using namespace Grid;
using namespace QCD;
using namespace Hadrons; using namespace Hadrons;
int main(int argc, char *argv[]) int main(int argc, char *argv[])

View File

@ -30,7 +30,7 @@ See the full license in the file "LICENSE" in the top level distribution directo
#include <Grid/Hadrons/Application.hpp> #include <Grid/Hadrons/Application.hpp>
using namespace Grid; using namespace Grid;
using namespace QCD;
using namespace Hadrons; using namespace Hadrons;
int main(int argc, char *argv[]) int main(int argc, char *argv[])

View File

@ -30,7 +30,7 @@ See the full license in the file "LICENSE" in the top level distribution directo
#include <Grid/Hadrons/Module.hpp> #include <Grid/Hadrons/Module.hpp>
using namespace Grid; using namespace Grid;
using namespace QCD;
using namespace Hadrons; using namespace Hadrons;
/****************************************************************************** /******************************************************************************

View File

@ -31,7 +31,7 @@ See the full license in the file "LICENSE" in the top level distribution directo
#include <Grid/Hadrons/ModuleFactory.hpp> #include <Grid/Hadrons/ModuleFactory.hpp>
using namespace Grid; using namespace Grid;
using namespace QCD;
using namespace Hadrons; using namespace Hadrons;
/****************************************************************************** /******************************************************************************

View File

@ -516,7 +516,9 @@ zolotarev_data* higham(PRECISION epsilon, int n) {
free(d); free(d);
return zd; return zd;
} }
}}
NAMESPACE_END(Approx);
NAMESPACE_END(Grid);
#ifdef TEST #ifdef TEST
@ -585,6 +587,7 @@ static PRECISION zolotarev_cayley_eval(PRECISION x, zolotarev_data* rdata) {
return (ONE - T) / (ONE + T); return (ONE - T) / (ONE + T);
} }
/* Test program. Apart from printing out the parameters for R(x) it produces /* Test program. Apart from printing out the parameters for R(x) it produces
* the following data files for plotting (unless NPLOT is defined): * the following data files for plotting (unless NPLOT is defined):
* *
@ -724,5 +727,4 @@ int main(int argc, char** argv) {
} }
#endif /* TEST */ #endif /* TEST */
NAMESPACE_END(Approx);
NAMESPACE_END(Grid);

View File

@ -177,14 +177,14 @@ template<class vobj> inline void PrepareMetaData(Lattice<vobj> & field, FieldMet
inline void GaugeStatistics(Lattice<vLorentzColourMatrixF> & data,FieldMetaData &header) inline void GaugeStatistics(Lattice<vLorentzColourMatrixF> & data,FieldMetaData &header)
{ {
// How to convert data precision etc... // How to convert data precision etc...
header.link_trace=Grid::QCD::WilsonLoops<PeriodicGimplF>::linkTrace(data); header.link_trace=WilsonLoops<PeriodicGimplF>::linkTrace(data);
header.plaquette =Grid::QCD::WilsonLoops<PeriodicGimplF>::avgPlaquette(data); header.plaquette =WilsonLoops<PeriodicGimplF>::avgPlaquette(data);
} }
inline void GaugeStatistics(Lattice<vLorentzColourMatrixD> & data,FieldMetaData &header) inline void GaugeStatistics(Lattice<vLorentzColourMatrixD> & data,FieldMetaData &header)
{ {
// How to convert data precision etc... // How to convert data precision etc...
header.link_trace=Grid::QCD::WilsonLoops<PeriodicGimplD>::linkTrace(data); header.link_trace=WilsonLoops<PeriodicGimplD>::linkTrace(data);
header.plaquette =Grid::QCD::WilsonLoops<PeriodicGimplD>::avgPlaquette(data); header.plaquette =WilsonLoops<PeriodicGimplD>::avgPlaquette(data);
} }
template<> inline void PrepareMetaData<vLorentzColourMatrixF>(Lattice<vLorentzColourMatrixF> & field, FieldMetaData &header) template<> inline void PrepareMetaData<vLorentzColourMatrixF>(Lattice<vLorentzColourMatrixF> & field, FieldMetaData &header)
{ {

View File

@ -168,6 +168,6 @@ public:
}; };
}; };
NAMESPACE_END(Grid): NAMESPACE_END(Grid);
#endif #endif

View File

@ -36,7 +36,7 @@ directory
NAMESPACE_BEGIN(Grid); NAMESPACE_BEGIN(Grid);
template <class Impl> template <class Impl>
class ScalarAction : public QCD::Action<typename Impl::Field> { class ScalarAction : public Action<typename Impl::Field> {
public: public:
INHERIT_FIELD_TYPES(Impl); INHERIT_FIELD_TYPES(Impl);
@ -58,7 +58,7 @@ public:
virtual void refresh(const Field &U, GridParallelRNG &pRNG) {} // noop as no pseudoferms virtual void refresh(const Field &U, GridParallelRNG &pRNG) {} // noop as no pseudoferms
virtual RealD S(const Field &p) { virtual RealD S(const Field &p) {
return (mass_square * 0.5 + QCD::Nd) * ScalarObs<Impl>::sumphisquared(p) + return (mass_square * 0.5 + Nd) * ScalarObs<Impl>::sumphisquared(p) +
(lambda / 24.) * ScalarObs<Impl>::sumphifourth(p) + (lambda / 24.) * ScalarObs<Impl>::sumphifourth(p) +
ScalarObs<Impl>::sumphider(p); ScalarObs<Impl>::sumphider(p);
}; };
@ -69,9 +69,9 @@ public:
Field p2(p._grid); Field p2(p._grid);
ScalarObs<Impl>::phisquared(p2, p); ScalarObs<Impl>::phisquared(p2, p);
tmp = -(Cshift(p, 0, -1) + Cshift(p, 0, 1)); tmp = -(Cshift(p, 0, -1) + Cshift(p, 0, 1));
for (int mu = 1; mu < QCD::Nd; mu++) tmp -= Cshift(p, mu, -1) + Cshift(p, mu, 1); for (int mu = 1; mu < Nd; mu++) tmp -= Cshift(p, mu, -1) + Cshift(p, mu, 1);
force =+(mass_square + 2. * QCD::Nd) * p + (lambda / 6.) * p2 * p + tmp; force =+(mass_square + 2. * Nd) * p + (lambda / 6.) * p2 * p + tmp;
} }
}; };

View File

@ -91,7 +91,7 @@ template <class S, unsigned int N>
class ScalarAdjMatrixImplTypes { class ScalarAdjMatrixImplTypes {
public: public:
typedef S Simd; typedef S Simd;
typedef QCD::SU<N> Group; typedef SU<N> Group;
template <typename vtype> template <typename vtype>
using iImplField = iScalar<iScalar<iMatrix<vtype, N>>>; using iImplField = iScalar<iScalar<iMatrix<vtype, N>>>;
@ -146,9 +146,9 @@ typedef ScalarImplTypes<vComplexF> ScalarImplCF;
typedef ScalarImplTypes<vComplexD> ScalarImplCD; typedef ScalarImplTypes<vComplexD> ScalarImplCD;
// Hardcoding here the size of the matrices // Hardcoding here the size of the matrices
typedef ScalarAdjMatrixImplTypes<vComplex, QCD::Nc> ScalarAdjImplR; typedef ScalarAdjMatrixImplTypes<vComplex, Nc> ScalarAdjImplR;
typedef ScalarAdjMatrixImplTypes<vComplexF, QCD::Nc> ScalarAdjImplF; typedef ScalarAdjMatrixImplTypes<vComplexF, Nc> ScalarAdjImplF;
typedef ScalarAdjMatrixImplTypes<vComplexD, QCD::Nc> ScalarAdjImplD; typedef ScalarAdjMatrixImplTypes<vComplexD, Nc> ScalarAdjImplD;
template <int Colours > using ScalarNxNAdjImplR = ScalarAdjMatrixImplTypes<vComplex, Colours >; template <int Colours > using ScalarNxNAdjImplR = ScalarAdjMatrixImplTypes<vComplex, Colours >;
template <int Colours > using ScalarNxNAdjImplF = ScalarAdjMatrixImplTypes<vComplexF, Colours >; template <int Colours > using ScalarNxNAdjImplF = ScalarAdjMatrixImplTypes<vComplexF, Colours >;

View File

@ -36,7 +36,7 @@ directory
NAMESPACE_BEGIN(Grid); NAMESPACE_BEGIN(Grid);
template <class Impl, int Ndim > template <class Impl, int Ndim >
class ScalarInteractionAction : public QCD::Action<typename Impl::Field> { class ScalarInteractionAction : public Action<typename Impl::Field> {
public: public:
INHERIT_FIELD_TYPES(Impl); INHERIT_FIELD_TYPES(Impl);
private: private:
@ -116,7 +116,7 @@ public:
static Stencil phiStencil(p._grid, npoint, 0, directions, displacements); static Stencil phiStencil(p._grid, npoint, 0, directions, displacements);
phiStencil.HaloExchange(p, compressor); phiStencil.HaloExchange(p, compressor);
//for (int mu = 0; mu < QCD::Nd; mu++) force -= Cshift(p, mu, -1) + Cshift(p, mu, 1); //for (int mu = 0; mu < Nd; mu++) force -= Cshift(p, mu, -1) + Cshift(p, mu, 1);
for (int point = 0; point < npoint; point++) { for (int point = 0; point < npoint; point++) {
parallel_for (int i = 0; i < p._grid->oSites(); i++) { parallel_for (int i = 0; i < p._grid->oSites(); i++) {
const vobj *temp; const vobj *temp;

View File

@ -53,9 +53,9 @@ NAMESPACE_BEGIN(Grid);
// HMC Resource manager // HMC Resource manager
template <class ImplementationPolicy> template <class ImplementationPolicy>
class HMCResourceManager { class HMCResourceManager {
typedef HMCModuleBase< QCD::BaseHmcCheckpointer<ImplementationPolicy> > CheckpointerBaseModule; typedef HMCModuleBase< BaseHmcCheckpointer<ImplementationPolicy> > CheckpointerBaseModule;
typedef HMCModuleBase< QCD::HmcObservable<typename ImplementationPolicy::Field> > ObservableBaseModule; typedef HMCModuleBase< HmcObservable<typename ImplementationPolicy::Field> > ObservableBaseModule;
typedef ActionModuleBase< QCD::Action<typename ImplementationPolicy::Field>, GridModule > ActionBaseModule; typedef ActionModuleBase< Action<typename ImplementationPolicy::Field>, GridModule > ActionBaseModule;
// Named storage for grid pairs (std + red-black) // Named storage for grid pairs (std + red-black)
std::unordered_map<std::string, GridModule> Grids; std::unordered_map<std::string, GridModule> Grids;

View File

@ -36,18 +36,18 @@ NAMESPACE_BEGIN(Grid);
// if we had a virtual reader would have been unecessary // if we had a virtual reader would have been unecessary
template <class HMCType, class ReaderClass > template <class HMCType, class ReaderClass >
class HMCModule class HMCModule
: public Parametrized< QCD::HMCparameters >, : public Parametrized< HMCparameters >,
public HMCModuleBase< QCD::HMCRunnerBase<ReaderClass> > { public HMCModuleBase< HMCRunnerBase<ReaderClass> > {
public: public:
typedef HMCModuleBase< QCD::HMCRunnerBase<ReaderClass> > Base; typedef HMCModuleBase< HMCRunnerBase<ReaderClass> > Base;
typedef typename Base::Product Product; typedef typename Base::Product Product;
std::unique_ptr<HMCType> HMCPtr; std::unique_ptr<HMCType> HMCPtr;
HMCModule(QCD::HMCparameters Par) : Parametrized<QCD::HMCparameters>(Par) {} HMCModule(HMCparameters Par) : Parametrized<HMCparameters>(Par) {}
template <class ReaderCl> template <class ReaderCl>
HMCModule(Reader<ReaderCl>& R) : Parametrized<QCD::HMCparameters>(R, "HMC"){}; HMCModule(Reader<ReaderCl>& R) : Parametrized<HMCparameters>(R, "HMC"){};
Product* getPtr() { Product* getPtr() {
if (!HMCPtr) initialize(); if (!HMCPtr) initialize();
@ -62,7 +62,7 @@ private:
// Factory // Factory
template <char const *str, class ReaderClass > template <char const *str, class ReaderClass >
class HMCRunnerModuleFactory class HMCRunnerModuleFactory
: public Factory < HMCModuleBase< QCD::HMCRunnerBase<ReaderClass> > , Reader<ReaderClass> > { : public Factory < HMCModuleBase< HMCRunnerBase<ReaderClass> > , Reader<ReaderClass> > {
public: public:
typedef Reader<ReaderClass> TheReader; typedef Reader<ReaderClass> TheReader;
// use SINGLETON FUNCTOR MACRO HERE // use SINGLETON FUNCTOR MACRO HERE
@ -88,36 +88,36 @@ private:
// macro for these // macro for these
template < class ImplementationPolicy, class RepresentationPolicy, class ReaderClass > template < class ImplementationPolicy, class RepresentationPolicy, class ReaderClass >
class HMCLeapFrog: public HMCModule< QCD::GenericHMCRunnerTemplate<ImplementationPolicy, RepresentationPolicy, QCD::LeapFrog>, ReaderClass >{ class HMCLeapFrog: public HMCModule< GenericHMCRunnerTemplate<ImplementationPolicy, RepresentationPolicy, LeapFrog>, ReaderClass >{
typedef HMCModule< QCD::GenericHMCRunnerTemplate<ImplementationPolicy, RepresentationPolicy, QCD::LeapFrog>, ReaderClass > HMCBaseMod; typedef HMCModule< GenericHMCRunnerTemplate<ImplementationPolicy, RepresentationPolicy, LeapFrog>, ReaderClass > HMCBaseMod;
using HMCBaseMod::HMCBaseMod; using HMCBaseMod::HMCBaseMod;
// aquire resource // aquire resource
virtual void initialize(){ virtual void initialize(){
this->HMCPtr.reset(new QCD::GenericHMCRunnerTemplate<ImplementationPolicy, RepresentationPolicy, QCD::LeapFrog>(this->Par_) ); this->HMCPtr.reset(new GenericHMCRunnerTemplate<ImplementationPolicy, RepresentationPolicy, LeapFrog>(this->Par_) );
} }
}; };
template < class ImplementationPolicy, class RepresentationPolicy, class ReaderClass > template < class ImplementationPolicy, class RepresentationPolicy, class ReaderClass >
class HMCMinimumNorm2: public HMCModule< QCD::GenericHMCRunnerTemplate<ImplementationPolicy, RepresentationPolicy, QCD::MinimumNorm2>, ReaderClass >{ class HMCMinimumNorm2: public HMCModule< GenericHMCRunnerTemplate<ImplementationPolicy, RepresentationPolicy, MinimumNorm2>, ReaderClass >{
typedef HMCModule< QCD::GenericHMCRunnerTemplate<ImplementationPolicy, RepresentationPolicy, QCD::MinimumNorm2>, ReaderClass > HMCBaseMod; typedef HMCModule< GenericHMCRunnerTemplate<ImplementationPolicy, RepresentationPolicy, MinimumNorm2>, ReaderClass > HMCBaseMod;
using HMCBaseMod::HMCBaseMod; using HMCBaseMod::HMCBaseMod;
// aquire resource // aquire resource
virtual void initialize(){ virtual void initialize(){
this->HMCPtr.reset(new QCD::GenericHMCRunnerTemplate<ImplementationPolicy, RepresentationPolicy, QCD::MinimumNorm2>(this->Par_)); this->HMCPtr.reset(new GenericHMCRunnerTemplate<ImplementationPolicy, RepresentationPolicy, MinimumNorm2>(this->Par_));
} }
}; };
template < class ImplementationPolicy, class RepresentationPolicy, class ReaderClass > template < class ImplementationPolicy, class RepresentationPolicy, class ReaderClass >
class HMCForceGradient: public HMCModule< QCD::GenericHMCRunnerTemplate<ImplementationPolicy, RepresentationPolicy, QCD::ForceGradient>, ReaderClass >{ class HMCForceGradient: public HMCModule< GenericHMCRunnerTemplate<ImplementationPolicy, RepresentationPolicy, ForceGradient>, ReaderClass >{
typedef HMCModule< QCD::GenericHMCRunnerTemplate<ImplementationPolicy, RepresentationPolicy, QCD::ForceGradient>, ReaderClass > HMCBaseMod; typedef HMCModule< GenericHMCRunnerTemplate<ImplementationPolicy, RepresentationPolicy, ForceGradient>, ReaderClass > HMCBaseMod;
using HMCBaseMod::HMCBaseMod; using HMCBaseMod::HMCBaseMod;
// aquire resource // aquire resource
virtual void initialize(){ virtual void initialize(){
this->HMCPtr.reset(new QCD::GenericHMCRunnerTemplate<ImplementationPolicy, RepresentationPolicy, QCD::ForceGradient>(this->Par_) ); this->HMCPtr.reset(new GenericHMCRunnerTemplate<ImplementationPolicy, RepresentationPolicy, ForceGradient>(this->Par_) );
} }
}; };

View File

@ -104,7 +104,6 @@ class GridFourDimModule : public GridModule
public: public:
GridFourDimModule() GridFourDimModule()
{ {
using namespace QCD;
set_full(SpaceTimeGrid::makeFourDimGrid( set_full(SpaceTimeGrid::makeFourDimGrid(
GridDefaultLatt(), GridDefaultLatt(),
GridDefaultSimd(4, vector_type::Nsimd()), GridDefaultSimd(4, vector_type::Nsimd()),
@ -114,7 +113,6 @@ public:
GridFourDimModule(const std::vector<int> tweak_simd) GridFourDimModule(const std::vector<int> tweak_simd)
{ {
using namespace QCD;
if (tweak_simd.size() != 4) if (tweak_simd.size() != 4)
{ {
std::cout << GridLogError std::cout << GridLogError
@ -148,7 +146,6 @@ public:
GridFourDimModule(const GridModuleParameters Params) GridFourDimModule(const GridModuleParameters Params)
{ {
using namespace QCD;
std::vector<int> lattice_v = Params.getLattice(); std::vector<int> lattice_v = Params.getLattice();
std::vector<int> mpi_v = Params.getMpi(); std::vector<int> mpi_v = Params.getMpi();
if (lattice_v.size() == 4) if (lattice_v.size() == 4)

View File

@ -52,9 +52,9 @@ public:
template <class ActionType, class APar> template <class ActionType, class APar>
class ActionModule class ActionModule
: public Parametrized<APar>, : public Parametrized<APar>,
public ActionModuleBase< QCD::Action<typename ActionType::GaugeField> , QCD::GridModule > { public ActionModuleBase< Action<typename ActionType::GaugeField> , GridModule > {
public: public:
typedef ActionModuleBase< QCD::Action<typename ActionType::GaugeField>, QCD::GridModule > Base; typedef ActionModuleBase< Action<typename ActionType::GaugeField>, GridModule > Base;
typedef typename Base::Product Product; typedef typename Base::Product Product;
typedef APar Parameters; typedef APar Parameters;
@ -467,31 +467,19 @@ public:
}; };
}// QCD temporarily here
//////////////////////////////////////// ////////////////////////////////////////
// Factories specialisations // Factories specialisations
//////////////////////////////////////// ////////////////////////////////////////
// use the same classed defined by Antonin, does not make sense to rewrite // use the same classed defined by Antonin, does not make sense to rewrite
// Factory is perfectly fine // Factory is perfectly fine
// Registar must be changed because I do not want to use the ModuleFactory // Registar must be changed because I do not want to use the ModuleFactory
// explicit ref to LatticeGaugeField must be changed or put in the factory // explicit ref to LatticeGaugeField must be changed or put in the factory
//typedef ActionModuleBase< QCD::Action< QCD::LatticeGaugeField >, QCD::GridModule > HMC_LGTActionModBase; //typedef ActionModuleBase< Action< LatticeGaugeField >, GridModule > HMC_LGTActionModBase;
//typedef ActionModuleBase< QCD::Action< QCD::LatticeReal >, QCD::GridModule > HMC_ScalarActionModBase; //typedef ActionModuleBase< Action< LatticeReal >, GridModule > HMC_ScalarActionModBase;
template <char const *str, class Field, class ReaderClass > template <char const *str, class Field, class ReaderClass >
class HMC_ActionModuleFactory class HMC_ActionModuleFactory
: public Factory < ActionModuleBase< QCD::Action< Field >, QCD::GridModule > , Reader<ReaderClass> > { : public Factory < ActionModuleBase< Action< Field >, GridModule > , Reader<ReaderClass> > {
public: public:
typedef Reader<ReaderClass> TheReader; typedef Reader<ReaderClass> TheReader;
// use SINGLETON FUNCTOR MACRO HERE // use SINGLETON FUNCTOR MACRO HERE

View File

@ -37,19 +37,19 @@ NAMESPACE_BEGIN(Grid);
template < class Product> template < class Product>
class FermionOperatorModuleBase : public HMCModuleBase<Product>{ class FermionOperatorModuleBase : public HMCModuleBase<Product>{
public: public:
virtual void AddGridPair(QCD::GridModule&) = 0; virtual void AddGridPair(GridModule&) = 0;
}; };
template <template <typename> class FOType, class FermionImpl, class FOPar> template <template <typename> class FOType, class FermionImpl, class FOPar>
class FermionOperatorModule class FermionOperatorModule
: public Parametrized<FOPar>, : public Parametrized<FOPar>,
public FermionOperatorModuleBase<QCD::FermionOperator<FermionImpl> > { public FermionOperatorModuleBase<FermionOperator<FermionImpl> > {
protected: protected:
std::unique_ptr< FOType<FermionImpl> > FOPtr; std::unique_ptr< FOType<FermionImpl> > FOPtr;
std::vector< QCD::GridModule* > GridRefs; std::vector< GridModule* > GridRefs;
public: public:
typedef HMCModuleBase< QCD::FermionOperator<FermionImpl> > Base; typedef HMCModuleBase< FermionOperator<FermionImpl> > Base;
typedef typename Base::Product Product; typedef typename Base::Product Product;
FermionOperatorModule(FOPar Par) : Parametrized<FOPar>(Par) {} FermionOperatorModule(FOPar Par) : Parametrized<FOPar>(Par) {}
@ -57,7 +57,7 @@ public:
template <class ReaderClass> template <class ReaderClass>
FermionOperatorModule(Reader<ReaderClass>& Reader) : Parametrized<FOPar>(Reader){}; FermionOperatorModule(Reader<ReaderClass>& Reader) : Parametrized<FOPar>(Reader){};
void AddGridPair(QCD::GridModule &Mod){ void AddGridPair(GridModule &Mod){
if (GridRefs.size()>1){ if (GridRefs.size()>1){
std::cout << GridLogError << "Adding too many Grids to the FermionOperatorModule" << std::endl; std::cout << GridLogError << "Adding too many Grids to the FermionOperatorModule" << std::endl;
exit(1); exit(1);
@ -65,9 +65,9 @@ public:
GridRefs.push_back(&Mod); GridRefs.push_back(&Mod);
if (Ls()){ if (Ls()){
GridRefs.push_back(new QCD::GridModule()); GridRefs.push_back(new GridModule());
GridRefs[1]->set_full(QCD::SpaceTimeGrid::makeFiveDimGrid(Ls(),GridRefs[0]->get_full())); GridRefs[1]->set_full(SpaceTimeGrid::makeFiveDimGrid(Ls(),GridRefs[0]->get_full()));
GridRefs[1]->set_rb(QCD::SpaceTimeGrid::makeFiveDimRedBlackGrid(Ls(),GridRefs[0]->get_full())); GridRefs[1]->set_rb(SpaceTimeGrid::makeFiveDimRedBlackGrid(Ls(),GridRefs[0]->get_full()));
} }
} }
@ -94,7 +94,7 @@ private:
// Factory // Factory
template <char const *str, class FermionImpl, class ReaderClass > template <char const *str, class FermionImpl, class ReaderClass >
class HMC_FermionOperatorModuleFactory class HMC_FermionOperatorModuleFactory
: public Factory < FermionOperatorModuleBase<QCD::FermionOperator<FermionImpl> > , Reader<ReaderClass> > { : public Factory < FermionOperatorModuleBase<FermionOperator<FermionImpl> > , Reader<ReaderClass> > {
public: public:
// use SINGLETON FUNCTOR MACRO HERE // use SINGLETON FUNCTOR MACRO HERE
typedef Reader<ReaderClass> TheReader; typedef Reader<ReaderClass> TheReader;

View File

@ -37,9 +37,9 @@ NAMESPACE_BEGIN(Grid);
template <class ObservableType, class OPar> template <class ObservableType, class OPar>
class ObservableModule class ObservableModule
: public Parametrized<OPar>, : public Parametrized<OPar>,
public HMCModuleBase< QCD::HmcObservable<typename ObservableType::Field> > { public HMCModuleBase< HmcObservable<typename ObservableType::Field> > {
public: public:
typedef HMCModuleBase< QCD::HmcObservable< typename ObservableType::Field> > Base; typedef HMCModuleBase< HmcObservable< typename ObservableType::Field> > Base;
typedef typename Base::Product Product; typedef typename Base::Product Product;
typedef OPar Parameters; typedef OPar Parameters;
@ -105,19 +105,15 @@ public:
TopologicalChargeMod(): ObsBase(){} TopologicalChargeMod(): ObsBase(){}
}; };
}// QCD temporarily here
//////////////////////////////////////// ////////////////////////////////////////
// Factories specialisations // Factories specialisations
//////////////////////////////////////// ////////////////////////////////////////
// explicit ref to LatticeGaugeField must be changed or put in the factory // explicit ref to LatticeGaugeField must be changed or put in the factory
//typedef HMCModuleBase< QCD::HmcObservable<QCD::LatticeGaugeField> > HMC_ObsModBase; //typedef HMCModuleBase< HmcObservable<LatticeGaugeField> > HMC_ObsModBase;
template <char const *str, class Field, class ReaderClass > template <char const *str, class Field, class ReaderClass >
class HMC_ObservablesModuleFactory class HMC_ObservablesModuleFactory
: public Factory < HMCModuleBase< QCD::HmcObservable<Field> >, Reader<ReaderClass> > { : public Factory < HMCModuleBase< HmcObservable<Field> >, Reader<ReaderClass> > {
public: public:
typedef Reader<ReaderClass> TheReader; typedef Reader<ReaderClass> TheReader;
// use SINGLETON FUNCTOR MACRO HERE // use SINGLETON FUNCTOR MACRO HERE

View File

@ -39,10 +39,10 @@ See the full license in the file "LICENSE" in the top level distribution directo
NAMESPACE_BEGIN(Grid); NAMESPACE_BEGIN(Grid);
// Dirac algebra adjoint operator (not in QCD:: to overload other adj) // Dirac algebra adjoint operator (not in to overload other adj)
inline QCD::Gamma adj(const QCD::Gamma &g) inline Gamma adj(const Gamma &g)
{ {
return QCD::Gamma (QCD::Gamma::adj[g.g]); return Gamma (Gamma::adj[g.g]);
} }

View File

@ -352,21 +352,21 @@ void Grid_init(int *argc,char ***argv)
//////////////////////////////////// ////////////////////////////////////
if( GridCmdOptionExists(*argv,*argv+*argc,"--dslash-unroll") ){ if( GridCmdOptionExists(*argv,*argv+*argc,"--dslash-unroll") ){
QCD::WilsonKernelsStatic::Opt=QCD::WilsonKernelsStatic::OptHandUnroll; WilsonKernelsStatic::Opt=WilsonKernelsStatic::OptHandUnroll;
QCD::StaggeredKernelsStatic::Opt=QCD::StaggeredKernelsStatic::OptHandUnroll; StaggeredKernelsStatic::Opt=StaggeredKernelsStatic::OptHandUnroll;
} }
if( GridCmdOptionExists(*argv,*argv+*argc,"--dslash-asm") ){ if( GridCmdOptionExists(*argv,*argv+*argc,"--dslash-asm") ){
QCD::WilsonKernelsStatic::Opt=QCD::WilsonKernelsStatic::OptInlineAsm; WilsonKernelsStatic::Opt=WilsonKernelsStatic::OptInlineAsm;
QCD::StaggeredKernelsStatic::Opt=QCD::StaggeredKernelsStatic::OptInlineAsm; StaggeredKernelsStatic::Opt=StaggeredKernelsStatic::OptInlineAsm;
} }
if( GridCmdOptionExists(*argv,*argv+*argc,"--dslash-generic") ){ if( GridCmdOptionExists(*argv,*argv+*argc,"--dslash-generic") ){
QCD::WilsonKernelsStatic::Opt=QCD::WilsonKernelsStatic::OptGeneric; WilsonKernelsStatic::Opt=WilsonKernelsStatic::OptGeneric;
QCD::StaggeredKernelsStatic::Opt=QCD::StaggeredKernelsStatic::OptGeneric; StaggeredKernelsStatic::Opt=StaggeredKernelsStatic::OptGeneric;
} }
if( GridCmdOptionExists(*argv,*argv+*argc,"--comms-overlap") ){ if( GridCmdOptionExists(*argv,*argv+*argc,"--comms-overlap") ){
QCD::WilsonKernelsStatic::Comms = QCD::WilsonKernelsStatic::CommsAndCompute; WilsonKernelsStatic::Comms = WilsonKernelsStatic::CommsAndCompute;
} else { } else {
QCD::WilsonKernelsStatic::Comms = QCD::WilsonKernelsStatic::CommsThenCompute; WilsonKernelsStatic::Comms = WilsonKernelsStatic::CommsThenCompute;
} }
if( GridCmdOptionExists(*argv,*argv+*argc,"--comms-concurrent") ){ if( GridCmdOptionExists(*argv,*argv+*argc,"--comms-concurrent") ){
CartesianCommunicator::SetCommunicatorPolicy(CartesianCommunicator::CommunicatorPolicyConcurrent); CartesianCommunicator::SetCommunicatorPolicy(CartesianCommunicator::CommunicatorPolicyConcurrent);

View File

@ -31,7 +31,7 @@ Author: paboyle <paboyle@ph.ed.ac.uk>
using namespace std; using namespace std;
using namespace Grid; using namespace Grid;
using namespace Grid::QCD; ;
int main (int argc, char ** argv) int main (int argc, char ** argv)

View File

@ -31,7 +31,7 @@ Author: paboyle <paboyle@ph.ed.ac.uk>
using namespace std; using namespace std;
using namespace Grid; using namespace Grid;
using namespace Grid::QCD; ;
int main (int argc, char ** argv) int main (int argc, char ** argv)

View File

@ -31,7 +31,7 @@ Author: paboyle <paboyle@ph.ed.ac.uk>
using namespace std; using namespace std;
using namespace Grid; using namespace Grid;
using namespace Grid::QCD; ;
int main (int argc, char ** argv) int main (int argc, char ** argv)

View File

@ -31,7 +31,7 @@ Author: paboyle <paboyle@ph.ed.ac.uk>
using namespace std; using namespace std;
using namespace Grid; using namespace Grid;
using namespace Grid::QCD; ;
int main (int argc, char ** argv) int main (int argc, char ** argv)

View File

@ -30,7 +30,7 @@ Author: Peter Boyle <paboyle@ph.ed.ac.uk>
#include <Grid/Grid.h> #include <Grid/Grid.h>
using namespace Grid; using namespace Grid;
using namespace Grid::QCD; ;
GRID_SERIALIZABLE_ENUM(myenum, undef, red, 1, blue, 2, green, 3); GRID_SERIALIZABLE_ENUM(myenum, undef, red, 1, blue, 2, green, 3);

View File

@ -29,7 +29,7 @@ Author: Peter Boyle <paboyle@ph.ed.ac.uk>
using namespace std; using namespace std;
using namespace Grid; using namespace Grid;
using namespace Grid::QCD; ;
template<class d> template<class d>
struct scal { struct scal {

View File

@ -29,7 +29,7 @@ Author: Peter Boyle <paboyle@ph.ed.ac.uk>
#include <Grid/Grid.h> #include <Grid/Grid.h>
using namespace Grid; using namespace Grid;
using namespace Grid::QCD; ;
int main (int argc, char ** argv) int main (int argc, char ** argv)
{ {

View File

@ -29,7 +29,7 @@ Author: Peter Boyle <paboyle@ph.ed.ac.uk>
using namespace std; using namespace std;
using namespace Grid; using namespace Grid;
using namespace Grid::QCD; ;
template<class d> template<class d>
struct scal { struct scal {

View File

@ -29,7 +29,7 @@ Author: Peter Boyle <paboyle@ph.ed.ac.uk>
using namespace std; using namespace std;
using namespace Grid; using namespace Grid;
using namespace Grid::QCD; ;
template<class d> template<class d>
struct scal { struct scal {

View File

@ -30,7 +30,7 @@ with this program; if not, write to the Free Software Foundation, Inc.,
using namespace std; using namespace std;
using namespace Grid; using namespace Grid;
using namespace Grid::QCD; ;
class funcPlus { class funcPlus {
public: public:

View File

@ -31,7 +31,7 @@ Author: paboyle <paboyle@ph.ed.ac.uk>
using namespace std; using namespace std;
using namespace Grid; using namespace Grid;
using namespace Grid::QCD; ;
int main(int argc, char ** argv) { int main(int argc, char ** argv) {
Grid_init(&argc, &argv); Grid_init(&argc, &argv);

View File

@ -31,7 +31,7 @@ Author: paboyle <paboyle@ph.ed.ac.uk>
using namespace std; using namespace std;
using namespace Grid; using namespace Grid;
using namespace Grid::QCD; ;
/* For Metropolis */ /* For Metropolis */

View File

@ -30,7 +30,7 @@ Author: paboyle <paboyle@ph.ed.ac.uk>
using namespace std; using namespace std;
using namespace Grid; using namespace Grid;
using namespace Grid::QCD; ;
/* For Metropolis */ /* For Metropolis */

View File

@ -29,7 +29,7 @@ Author: Peter Boyle <paboyle@ph.ed.ac.uk>
using namespace std; using namespace std;
using namespace Grid; using namespace Grid;
using namespace Grid::QCD; ;
template<class d> template<class d>
struct scal { struct scal {

View File

@ -30,7 +30,7 @@ Author: Peter Boyle <paboyle@ph.ed.ac.uk>
using namespace std; using namespace std;
using namespace Grid; using namespace Grid;
using namespace Grid::QCD; ;
template<class d> template<class d>
struct scal { struct scal {

View File

@ -29,7 +29,7 @@ Author: Peter Boyle <paboyle@ph.ed.ac.uk>
using namespace std; using namespace std;
using namespace Grid; using namespace Grid;
using namespace Grid::QCD; ;
template<class d> template<class d>
struct scal { struct scal {

View File

@ -30,7 +30,7 @@ Author: paboyle <paboyle@ph.ed.ac.uk>
#include <Grid/Grid.h> #include <Grid/Grid.h>
using namespace Grid; using namespace Grid;
using namespace Grid::QCD; ;
#define POWER10 #define POWER10

View File

@ -30,7 +30,7 @@ Author: paboyle <paboyle@ph.ed.ac.uk>
#include <Grid/Grid.h> #include <Grid/Grid.h>
using namespace Grid; using namespace Grid;
using namespace Grid::QCD; ;
#define POWER10 #define POWER10

View File

@ -29,7 +29,7 @@ Author: Peter Boyle <paboyle@ph.ed.ac.uk>
#include <Grid/Grid.h> #include <Grid/Grid.h>
using namespace Grid; using namespace Grid;
using namespace Grid::QCD; ;
int main (int argc, char ** argv) int main (int argc, char ** argv)
{ {

View File

@ -32,7 +32,7 @@ See the full license in the file "LICENSE" in the top level distribution directo
using namespace std; using namespace std;
using namespace Grid; using namespace Grid;
using namespace Grid::QCD; ;
template<class d> template<class d>
struct scal { struct scal {

View File

@ -30,7 +30,7 @@ Author: paboyle <paboyle@ph.ed.ac.uk>
using namespace std; using namespace std;
using namespace Grid; using namespace Grid;
using namespace Grid::QCD; ;
template<class d> template<class d>
struct scal { struct scal {

View File

@ -30,7 +30,7 @@ Author: paboyle <paboyle@ph.ed.ac.uk>
using namespace std; using namespace std;
using namespace Grid; using namespace Grid;
using namespace Grid::QCD; ;
template<class d> template<class d>
struct scal { struct scal {

View File

@ -29,7 +29,7 @@ Author: Peter Boyle <paboyle@ph.ed.ac.uk>
#include <Grid/Grid.h> #include <Grid/Grid.h>
using namespace Grid; using namespace Grid;
using namespace Grid::QCD; ;
int main (int argc, char ** argv) int main (int argc, char ** argv)
{ {

View File

@ -29,7 +29,7 @@ Author: Peter Boyle <paboyle@ph.ed.ac.uk>
#include <Grid/Grid.h> #include <Grid/Grid.h>
using namespace Grid; using namespace Grid;
using namespace Grid::QCD; ;
int main (int argc, char ** argv) int main (int argc, char ** argv)
{ {

View File

@ -29,7 +29,7 @@ Author: Peter Boyle <paboyle@ph.ed.ac.uk>
#include <Grid/Grid.h> #include <Grid/Grid.h>
using namespace Grid; using namespace Grid;
using namespace Grid::QCD; ;
int main (int argc, char ** argv) int main (int argc, char ** argv)
{ {

View File

@ -31,7 +31,7 @@ Author: paboyle <paboyle@ph.ed.ac.uk>
using namespace std; using namespace std;
using namespace Grid; using namespace Grid;
using namespace Grid::QCD; ;
//typedef GparityDomainWallFermionD GparityDiracOp; //typedef GparityDomainWallFermionD GparityDiracOp;
//typedef DomainWallFermionD StandardDiracOp; //typedef DomainWallFermionD StandardDiracOp;

View File

@ -30,7 +30,7 @@ Author: paboyle <paboyle@ph.ed.ac.uk>
using namespace std; using namespace std;
using namespace Grid; using namespace Grid;
using namespace Grid::QCD; ;
int main (int argc, char ** argv) int main (int argc, char ** argv)
{ {

View File

@ -42,7 +42,7 @@ directory
using namespace std; using namespace std;
using namespace Grid; using namespace Grid;
using namespace Grid::QCD; ;
int main(int argc, char** argv) { int main(int argc, char** argv) {
Grid_init(&argc, &argv); Grid_init(&argc, &argv);

View File

@ -32,7 +32,7 @@ with this program; if not, write to the Free Software Foundation, Inc.,
using namespace std; using namespace std;
using namespace Grid; using namespace Grid;
using namespace Grid::QCD; ;
/* /*
Grid_main.cc(232): error: no suitable user-defined conversion from Grid_main.cc(232): error: no suitable user-defined conversion from

View File

@ -32,7 +32,7 @@ See the full license in the file "LICENSE" in the top level distribution directo
using namespace std; using namespace std;
using namespace Grid; using namespace Grid;
using namespace Grid::QCD; ;
template<class d> template<class d>
struct scal { struct scal {

View File

@ -30,7 +30,7 @@ Author: paboyle <paboyle@ph.ed.ac.uk>
using namespace std; using namespace std;
using namespace Grid; using namespace Grid;
using namespace Grid::QCD; ;
template<class d> template<class d>
struct scal { struct scal {

View File

@ -29,7 +29,7 @@ Author: Peter Boyle <paboyle@ph.ed.ac.uk>
#include <Grid/Grid.h> #include <Grid/Grid.h>
using namespace Grid; using namespace Grid;
using namespace Grid::QCD; ;
int main (int argc, char ** argv) int main (int argc, char ** argv)
{ {

View File

@ -30,7 +30,7 @@ Author: Peter Boyle <paboyle@ph.ed.ac.uk>
using namespace std; using namespace std;
using namespace Grid; using namespace Grid;
using namespace Grid::QCD; ;
int main (int argc, char ** argv) int main (int argc, char ** argv)
{ {

View File

@ -29,7 +29,7 @@ Author: Peter Boyle <paboyle@ph.ed.ac.uk>
using namespace std; using namespace std;
using namespace Grid; using namespace Grid;
using namespace Grid::QCD; ;
int main (int argc, char ** argv) int main (int argc, char ** argv)
{ {

View File

@ -29,7 +29,7 @@ Author: Peter Boyle <paboyle@ph.ed.ac.uk>
using namespace std; using namespace std;
using namespace Grid; using namespace Grid;
using namespace Grid::QCD; ;
int main (int argc, char ** argv) int main (int argc, char ** argv)
{ {

View File

@ -30,7 +30,7 @@ Author: paboyle <paboyle@ph.ed.ac.uk>
using namespace std; using namespace std;
using namespace Grid; using namespace Grid;
using namespace Grid::QCD; ;
int main (int argc, char ** argv) int main (int argc, char ** argv)
{ {

View File

@ -30,7 +30,7 @@ Author: paboyle <paboyle@ph.ed.ac.uk>
using namespace std; using namespace std;
using namespace Grid; using namespace Grid;
using namespace Grid::QCD; ;
int main (int argc, char ** argv) int main (int argc, char ** argv)
{ {

View File

@ -30,7 +30,7 @@ Author: paboyle <paboyle@ph.ed.ac.uk>
using namespace std; using namespace std;
using namespace Grid; using namespace Grid;
using namespace Grid::QCD; ;
int main (int argc, char ** argv) int main (int argc, char ** argv)
{ {

View File

@ -29,7 +29,7 @@ Author: paboyle <paboyle@ph.ed.ac.uk>
using namespace std; using namespace std;
using namespace Grid; using namespace Grid;
using namespace Grid::QCD; ;
template<class d> template<class d>
struct scal { struct scal {

View File

@ -30,7 +30,7 @@ Author: paboyle <paboyle@ph.ed.ac.uk>
using namespace std; using namespace std;
using namespace Grid; using namespace Grid;
using namespace Grid::QCD; ;
template<class d> template<class d>
struct scal { struct scal {

View File

@ -30,7 +30,7 @@ Author: paboyle <paboyle@ph.ed.ac.uk>
using namespace std; using namespace std;
using namespace Grid; using namespace Grid;
using namespace Grid::QCD; ;
template<class d> template<class d>
struct scal { struct scal {

View File

@ -30,7 +30,7 @@ Author: paboyle <paboyle@ph.ed.ac.uk>
using namespace std; using namespace std;
using namespace Grid; using namespace Grid;
using namespace Grid::QCD; ;
template<class d> template<class d>
struct scal { struct scal {

View File

@ -30,7 +30,7 @@ Author: Peter Boyle <paboyle@ph.ed.ac.uk>
using namespace std; using namespace std;
using namespace Grid; using namespace Grid;
using namespace Grid::QCD; ;
template<class d> template<class d>

View File

@ -29,7 +29,7 @@ Author: Peter Boyle <paboyle@ph.ed.ac.uk>
using namespace std; using namespace std;
using namespace Grid; using namespace Grid;
using namespace Grid::QCD; ;
template<class d> template<class d>
struct scal { struct scal {

View File

@ -29,7 +29,7 @@ Author: Peter Boyle <paboyle@ph.ed.ac.uk>
using namespace std; using namespace std;
using namespace Grid; using namespace Grid;
using namespace Grid::QCD; ;
int main (int argc, char ** argv) int main (int argc, char ** argv)
{ {

View File

@ -29,7 +29,7 @@ Author: Peter Boyle <paboyle@ph.ed.ac.uk>
using namespace std; using namespace std;
using namespace Grid; using namespace Grid;
using namespace Grid::QCD; ;
RealD InverseApproximation(RealD x){ RealD InverseApproximation(RealD x){
return 1.0/x; return 1.0/x;

View File

@ -38,7 +38,7 @@ Author: David Murphy <dmurphy@phys.columbia.edu>
using namespace std; using namespace std;
using namespace Grid; using namespace Grid;
using namespace Grid::QCD; ;
// Parameters for test // Parameters for test
const std::vector<int> grid_dim = { 8, 8, 8, 8 }; const std::vector<int> grid_dim = { 8, 8, 8, 8 };

View File

@ -38,7 +38,7 @@ Author: David Murphy <dmurphy@phys.columbia.edu>
using namespace std; using namespace std;
using namespace Grid; using namespace Grid;
using namespace Grid::QCD; ;
typedef GparityWilsonImplR FermionImplPolicy; typedef GparityWilsonImplR FermionImplPolicy;
typedef GparityDomainWallEOFAFermionR FermionAction; typedef GparityDomainWallEOFAFermionR FermionAction;

View File

@ -38,7 +38,7 @@ See the full license in the file "LICENSE" in the top level distribution directo
using namespace std; using namespace std;
using namespace Grid; using namespace Grid;
using namespace Grid::QCD; ;
// Parameters for test // Parameters for test
const std::vector<int> grid_dim = { 8, 8, 8, 8 }; const std::vector<int> grid_dim = { 8, 8, 8, 8 };

View File

@ -38,7 +38,7 @@ See the full license in the file "LICENSE" in the top level distribution directo
using namespace std; using namespace std;
using namespace Grid; using namespace Grid;
using namespace Grid::QCD; ;
typedef GparityWilsonImplR FermionImplPolicy; typedef GparityWilsonImplR FermionImplPolicy;
typedef GparityMobiusEOFAFermionR FermionAction; typedef GparityMobiusEOFAFermionR FermionAction;

View File

@ -31,7 +31,7 @@ See the full license in the file "LICENSE" in the top level distribution directo
using namespace std; using namespace std;
using namespace Grid; using namespace Grid;
using namespace Grid::QCD; ;
// parameters for test // parameters for test
const std::vector<int> grid_dim = { 8, 8, 8, 8 }; const std::vector<int> grid_dim = { 8, 8, 8, 8 };

View File

@ -31,7 +31,7 @@ See the full license in the file "LICENSE" in the top level distribution directo
using namespace std; using namespace std;
using namespace Grid; using namespace Grid;
using namespace Grid::QCD; ;
typedef typename GparityDomainWallFermionR::FermionField FermionField; typedef typename GparityDomainWallFermionR::FermionField FermionField;

View File

@ -31,7 +31,7 @@ See the full license in the file "LICENSE" in the top level distribution directo
using namespace std; using namespace std;
using namespace Grid; using namespace Grid;
using namespace Grid::QCD; ;
// parameters for test // parameters for test
const std::vector<int> grid_dim = { 8, 8, 8, 8 }; const std::vector<int> grid_dim = { 8, 8, 8, 8 };

View File

@ -31,7 +31,7 @@ See the full license in the file "LICENSE" in the top level distribution directo
using namespace std; using namespace std;
using namespace Grid; using namespace Grid;
using namespace Grid::QCD; ;
typedef typename GparityDomainWallFermionR::FermionField FermionField; typedef typename GparityDomainWallFermionR::FermionField FermionField;

View File

@ -37,7 +37,7 @@ int main(int argc,char **argv)
#if 0 #if 0
#include <simd/Intel512wilson.h> #include <simd/Intel512wilson.h>
using namespace Grid; using namespace Grid;
using namespace Grid::QCD; ;
void ZmulF(void *ptr1,void *ptr2,void *ptr3); void ZmulF(void *ptr1,void *ptr2,void *ptr3);
void Zmul(void *ptr1,void *ptr2,void *ptr3); void Zmul(void *ptr1,void *ptr2,void *ptr3);

View File

@ -29,7 +29,7 @@ Author: Peter Boyle <paboyle@ph.ed.ac.uk>
using namespace std; using namespace std;
using namespace Grid; using namespace Grid;
using namespace Grid::QCD; ;
template<class vobj> template<class vobj>
class LinearOperator { class LinearOperator {

View File

@ -29,7 +29,7 @@ Author: Peter Boyle <paboyle@ph.ed.ac.uk>
using namespace std; using namespace std;
using namespace Grid; using namespace Grid;
using namespace Grid::QCD; ;
int main (int argc, char ** argv) int main (int argc, char ** argv)
{ {

View File

@ -29,7 +29,7 @@ Author: Peter Boyle <paboyle@ph.ed.ac.uk>
using namespace std; using namespace std;
using namespace Grid; using namespace Grid;
using namespace Grid::QCD; ;
int main (int argc, char ** argv) int main (int argc, char ** argv)
{ {

View File

@ -31,7 +31,7 @@ See the full license in the file "LICENSE" in the top level distribution directo
using namespace std; using namespace std;
using namespace Grid; using namespace Grid;
using namespace Grid::QCD; ;
int main (int argc, char** argv) int main (int argc, char** argv)
{ {

View File

@ -29,7 +29,7 @@ Author: paboyle <paboyle@ph.ed.ac.uk>
using namespace std; using namespace std;
using namespace Grid; using namespace Grid;
using namespace Grid::QCD; ;

View File

@ -31,7 +31,7 @@ See the full license in the file "LICENSE" in the top level distribution directo
using namespace std; using namespace std;
using namespace Grid; using namespace Grid;
using namespace Grid::QCD; ;
typedef GparityWilsonImplR FermionImplPolicy; typedef GparityWilsonImplR FermionImplPolicy;
typedef GparityDomainWallEOFAFermionR FermionAction; typedef GparityDomainWallEOFAFermionR FermionAction;

View File

@ -29,7 +29,7 @@ Author: paboyle <paboyle@ph.ed.ac.uk>
using namespace std; using namespace std;
using namespace Grid; using namespace Grid;
using namespace Grid::QCD; ;

Some files were not shown because too many files have changed in this diff Show More