From 037bb6ea7397fcedddcd94515786849351e4d507 Mon Sep 17 00:00:00 2001 From: Daniel Richtmann Date: Mon, 16 Mar 2020 14:07:52 +0100 Subject: [PATCH 01/36] Check in reader for openqcd configs This reader is suboptimal in the sense that it opens the entire config on every MPI rank. --- Grid/parallelIO/OpenQcdIO.h | 153 +++++++++++++++++++++++++++++++++++ Grid/qcd/hmc/HMC_aggregate.h | 1 + tests/IO/Test_openqcd_io.cc | 55 +++++++++++++ 3 files changed, 209 insertions(+) create mode 100644 Grid/parallelIO/OpenQcdIO.h create mode 100644 tests/IO/Test_openqcd_io.cc diff --git a/Grid/parallelIO/OpenQcdIO.h b/Grid/parallelIO/OpenQcdIO.h new file mode 100644 index 00000000..f340e8fc --- /dev/null +++ b/Grid/parallelIO/OpenQcdIO.h @@ -0,0 +1,153 @@ +/************************************************************************************* + +Grid physics library, www.github.com/paboyle/Grid + +Source file: ./lib/parallelIO/OpenQcdIO.h + +Copyright (C) 2015 - 2020 + +Author: Daniel Richtmann + +This program is free software; you can redistribute it and/or modify +it under the terms of the GNU General Public License as published by +the Free Software Foundation; either version 2 of the License, or +(at your option) any later version. + +This program is distributed in the hope that it will be useful, +but WITHOUT ANY WARRANTY; without even the implied warranty of +MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the +GNU General Public License for more details. + +You should have received a copy of the GNU General Public License along +with this program; if not, write to the Free Software Foundation, Inc., +51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. + +See the full license in the file "LICENSE" in the top level distribution +directory +*************************************************************************************/ +/* END LEGAL */ +#pragma once + +NAMESPACE_BEGIN(Grid); + +struct OpenQcdHeader : Serializable { + GRID_SERIALIZABLE_CLASS_MEMBERS(OpenQcdHeader, + int, Nt, + int, Nx, + int, Ny, + int, Nz, + double, plaq); +}; + +class OpenQcdIO : public BinaryIO { +public: + static constexpr double normalisationFactor = Nc; // normalisation difference: grid 18, openqcd 6 + + static inline int readHeader(std::string file, GridBase* grid, FieldMetaData& field) { + OpenQcdHeader header; + + { + std::ifstream fin(file, std::ios::in | std::ios::binary); + fin.read(reinterpret_cast(&header), sizeof(OpenQcdHeader)); + assert(!fin.fail()); + field.data_start = fin.tellg(); + fin.close(); + } + + header.plaq /= normalisationFactor; + + // sanity check (should trigger on endian issues) + assert(0 < header.Nt && header.Nt <= 1024); + assert(0 < header.Nx && header.Nx <= 1024); + assert(0 < header.Ny && header.Ny <= 1024); + assert(0 < header.Nz && header.Nz <= 1024); + + field.dimension[0] = header.Nx; + field.dimension[1] = header.Ny; + field.dimension[2] = header.Nz; + field.dimension[3] = header.Nt; + + assert(grid->_ndimension == Nd); + for(int d = 0; d < Nd; d++) + assert(grid->_fdimensions[d] == field.dimension[d]); + + field.plaquette = header.plaq; + + return field.data_start; + } + + template + static inline void readConfiguration(Lattice>& Umu, + FieldMetaData& header, + std::string file) { + auto grid = dynamic_cast(Umu.Grid()); + assert(grid != nullptr); + assert((grid->_ndimension == Nd) && (Nd == 4)); + + uint64_t offset = readHeader(file, Umu.Grid(), header); + FieldMetaData clone(header); + + // NOTE: This version is suboptimal because we read in the full file on every rank + std::vector data(grid->gSites() * 4); + { + auto fin = std::fstream(file, std::ios::in | std::ios::binary); + fin.seekg(offset); + fin.read((char *)data.data(), data.size() * sizeof(ColourMatrix)); + fin.close(); + } + + // global lattice size + Coordinate fdim = grid->FullDimensions(); + + // coordinate of this process + Coordinate pcoor; + grid->ProcessorCoorFromRank(CartesianCommunicator::RankWorld(), pcoor); + + // loop over local indices + thread_for(idx, grid->lSites(), { + // convert local index to global coordinate + Coordinate lcoor, gcoor; + grid->LocalIndexToLocalCoor(idx, lcoor); + grid->ProcessorCoorLocalCoorToGlobalCoor(pcoor, lcoor, gcoor); + + // openQCD stores links attached to odd sites + bool neg = (gcoor[Xdir] + gcoor[Ydir] + gcoor[Zdir] + gcoor[Tdir]) % 2 != 1; + + LorentzColourMatrix site_data; + for (int mu = 0; mu < 4; ++mu) { + // determine the site at which it is stored + Coordinate c = gcoor; + if (neg) + c[mu] = (c[mu] + 1) % grid->FullDimensions()[mu]; + + // site-index in the OpenQCD format (which uses t,x,y,z order) + int openqcd_idx = (c[Tdir] * fdim[Xdir] * fdim[Ydir] * fdim[Zdir] + + c[Xdir] * fdim[Ydir] * fdim[Zdir] + + c[Ydir] * fdim[Zdir] + + c[Zdir])/2; + int openqcd_mu = (mu + 1) % 4; + + // pick the colour-matrix out + site_data(mu) = + data[8 * openqcd_idx + 2 * openqcd_mu + (neg ? 1 : 0)](); + } + + pokeLocalSite(site_data, Umu, lcoor); + }); + + GaugeStatistics(Umu, clone); + + std::cout << GridLogMessage << "OpenQcd Configuration " << file << " plaquette " + << std::setprecision(15) + << clone.plaquette << " header " << header.plaquette + << " difference " << fabs(clone.plaquette - header.plaquette) + << std::endl; + + if(fabs(clone.plaquette - header.plaquette) >= 1.0e-5) std::cout << " Plaquette mismatch " << std::endl; + assert(fabs(clone.plaquette - header.plaquette) < 1.0e-5); + + std::cout << GridLogMessage << "OpenQcd Configuration " << file << " and plaquette agree" << std::endl; + } +}; + +NAMESPACE_END(Grid); diff --git a/Grid/qcd/hmc/HMC_aggregate.h b/Grid/qcd/hmc/HMC_aggregate.h index e4d2ce83..94c745e1 100644 --- a/Grid/qcd/hmc/HMC_aggregate.h +++ b/Grid/qcd/hmc/HMC_aggregate.h @@ -39,6 +39,7 @@ directory #include #include #include +#include NAMESPACE_CHECK(Ildg); #include diff --git a/tests/IO/Test_openqcd_io.cc b/tests/IO/Test_openqcd_io.cc new file mode 100644 index 00000000..2a5769bd --- /dev/null +++ b/tests/IO/Test_openqcd_io.cc @@ -0,0 +1,55 @@ +/************************************************************************************* + +Grid physics library, www.github.com/paboyle/Grid + +Source file: ./tests/io/Test_openqcd_io.cc + +Copyright (C) 2015 - 2020 + +Author: Daniel Richtmann + +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 + +using namespace Grid; + +int main(int argc, char** argv) { + Grid_init(&argc, &argv); + + GridCartesian* grid = SpaceTimeGrid::makeFourDimGrid(GridDefaultLatt(), + GridDefaultSimd(Nd, vComplexD::Nsimd()), + GridDefaultMpi()); + + LatticeGaugeField Umu(grid); + + FieldMetaData header; + + if(!Grid::GridCmdOptionExists(argv, argv + argc, "--config")) { + std::cout << GridLogError << "You need to use --config /path/to/openqcd_config" << std::endl; + abort(); + } + + std::string file = Grid::GridCmdOptionPayload(argv, argv + argc, "--config"); + assert(!file.empty()); + + OpenQcdIO::readConfiguration(Umu, header, file); + + Grid_finalize(); +} From c9b737a4e7bb62cf6d22dace3458b108043e5023 Mon Sep 17 00:00:00 2001 From: Christoph Lehner Date: Mon, 16 Mar 2020 17:58:30 -0400 Subject: [PATCH 02/36] make trace,adj,transpose unary operators --- Grid/lattice/Lattice.h | 4 ++-- Grid/lattice/Lattice_trace.h | 2 ++ .../WilsonCloverFermionImplementation.h | 8 ++++---- Grid/qcd/action/gauge/GaugeImplementations.h | 2 +- Grid/qcd/utils/WilsonLoops.h | 4 ++-- bootstrap.sh | 15 ++++++++------- 6 files changed, 19 insertions(+), 16 deletions(-) diff --git a/Grid/lattice/Lattice.h b/Grid/lattice/Lattice.h index 1eea98ed..6eac0362 100644 --- a/Grid/lattice/Lattice.h +++ b/Grid/lattice/Lattice.h @@ -31,11 +31,11 @@ Author: Peter Boyle #include #include #include -#include +//#include #include #include #include -#include +//#include #include #include #include diff --git a/Grid/lattice/Lattice_trace.h b/Grid/lattice/Lattice_trace.h index 93444e0c..6b5f67d2 100644 --- a/Grid/lattice/Lattice_trace.h +++ b/Grid/lattice/Lattice_trace.h @@ -37,6 +37,7 @@ NAMESPACE_BEGIN(Grid); //////////////////////////////////////////////////////////////////////////////////////////////////// // Trace //////////////////////////////////////////////////////////////////////////////////////////////////// +/* template inline auto trace(const Lattice &lhs) -> Lattice { @@ -48,6 +49,7 @@ inline auto trace(const Lattice &lhs) -> Lattice }); return ret; }; +*/ //////////////////////////////////////////////////////////////////////////////////////////////////// // Trace Index level dependent operation diff --git a/Grid/qcd/action/fermion/implementation/WilsonCloverFermionImplementation.h b/Grid/qcd/action/fermion/implementation/WilsonCloverFermionImplementation.h index 5744d3bb..9d99d9e7 100644 --- a/Grid/qcd/action/fermion/implementation/WilsonCloverFermionImplementation.h +++ b/Grid/qcd/action/fermion/implementation/WilsonCloverFermionImplementation.h @@ -132,14 +132,14 @@ void WilsonCloverFermion::ImportGauge(const GaugeField &_Umu) pickCheckerboard(Even, CloverTermEven, CloverTerm); pickCheckerboard(Odd, CloverTermOdd, CloverTerm); - pickCheckerboard(Even, CloverTermDagEven, adj(CloverTerm)); - pickCheckerboard(Odd, CloverTermDagOdd, adj(CloverTerm)); + pickCheckerboard(Even, CloverTermDagEven, closure(adj(CloverTerm))); + pickCheckerboard(Odd, CloverTermDagOdd, closure(adj(CloverTerm))); pickCheckerboard(Even, CloverTermInvEven, CloverTermInv); pickCheckerboard(Odd, CloverTermInvOdd, CloverTermInv); - pickCheckerboard(Even, CloverTermInvDagEven, adj(CloverTermInv)); - pickCheckerboard(Odd, CloverTermInvDagOdd, adj(CloverTermInv)); + pickCheckerboard(Even, CloverTermInvDagEven, closure(adj(CloverTermInv))); + pickCheckerboard(Odd, CloverTermInvDagOdd, closure(adj(CloverTermInv))); } template diff --git a/Grid/qcd/action/gauge/GaugeImplementations.h b/Grid/qcd/action/gauge/GaugeImplementations.h index a14aec1b..19bc5aa6 100644 --- a/Grid/qcd/action/gauge/GaugeImplementations.h +++ b/Grid/qcd/action/gauge/GaugeImplementations.h @@ -59,7 +59,7 @@ public: } static inline GaugeLinkField CovShiftIdentityBackward(const GaugeLinkField &Link, int mu) { - return Cshift(adj(Link), mu, -1); + return Cshift(closure(adj(Link)), mu, -1); } static inline GaugeLinkField CovShiftIdentityForward(const GaugeLinkField &Link, int mu) { diff --git a/Grid/qcd/utils/WilsonLoops.h b/Grid/qcd/utils/WilsonLoops.h index 0367c9fa..fdd53698 100644 --- a/Grid/qcd/utils/WilsonLoops.h +++ b/Grid/qcd/utils/WilsonLoops.h @@ -485,7 +485,7 @@ public: // Up staple ___ ___ // | | - tmp = Cshift(adj(U[nu]), nu, -1); + tmp = Cshift(closure(adj(U[nu])), nu, -1); tmp = adj(U2[mu]) * tmp; tmp = Cshift(tmp, mu, -2); @@ -519,7 +519,7 @@ public: // // | | - tmp = Cshift(adj(U2[nu]), nu, -2); + tmp = Cshift(closure(adj(U2[nu])), nu, -2); tmp = Gimpl::CovShiftBackward(U[mu], mu, tmp); tmp = U2[nu] * Cshift(tmp, nu, 2); Stap += Cshift(tmp, mu, 1); diff --git a/bootstrap.sh b/bootstrap.sh index 4bd3de5e..5ea7ce32 100755 --- a/bootstrap.sh +++ b/bootstrap.sh @@ -1,19 +1,20 @@ #!/usr/bin/env bash set -e -EIGEN_URL='https://gitlab.com/libeigen/eigen/-/archive/3.3.7/eigen-3.3.7.tar.bz2' +#https://gitlab.com/libeigen/eigen/-/archive/3.3.7/eigen-3.3.7.tar.bz2 +EIGEN_URL='http://bitbucket.org/eigen/eigen/get/3.3.7.tar.bz2' EIGEN_SHA256SUM='685adf14bd8e9c015b78097c1dc22f2f01343756f196acdc76a678e1ae352e11' echo "-- deploying Eigen source..." ARC=`basename ${EIGEN_URL}` wget ${EIGEN_URL} --no-check-certificate -if command -v sha256sum; then - echo "$EIGEN_SHA256SUM $(basename "$EIGEN_URL")" \ - | sha256sum --check || exit 1 -else - echo "WARNING: could not verify checksum, please install sha256sum" >&2 -fi +#if command -v sha256sum; then +# echo "$EIGEN_SHA256SUM $(basename "$EIGEN_URL")" \ +# | sha256sum --check || exit 1 +#else +# echo "WARNING: could not verify checksum, please install sha256sum" >&2 +#fi ./scripts/update_eigen.sh ${ARC} rm ${ARC} # patch for non-portable includes in Eigen 3.3.5 From 60db3133d38e8e4433627e6351e38cafe210c175 Mon Sep 17 00:00:00 2001 From: Christoph Lehner Date: Mon, 16 Mar 2020 17:59:56 -0400 Subject: [PATCH 03/36] make trace,adj,transpose unary operators --- bootstrap.sh | 15 +++++++-------- 1 file changed, 7 insertions(+), 8 deletions(-) diff --git a/bootstrap.sh b/bootstrap.sh index 5ea7ce32..4bd3de5e 100755 --- a/bootstrap.sh +++ b/bootstrap.sh @@ -1,20 +1,19 @@ #!/usr/bin/env bash set -e -#https://gitlab.com/libeigen/eigen/-/archive/3.3.7/eigen-3.3.7.tar.bz2 -EIGEN_URL='http://bitbucket.org/eigen/eigen/get/3.3.7.tar.bz2' +EIGEN_URL='https://gitlab.com/libeigen/eigen/-/archive/3.3.7/eigen-3.3.7.tar.bz2' EIGEN_SHA256SUM='685adf14bd8e9c015b78097c1dc22f2f01343756f196acdc76a678e1ae352e11' echo "-- deploying Eigen source..." ARC=`basename ${EIGEN_URL}` wget ${EIGEN_URL} --no-check-certificate -#if command -v sha256sum; then -# echo "$EIGEN_SHA256SUM $(basename "$EIGEN_URL")" \ -# | sha256sum --check || exit 1 -#else -# echo "WARNING: could not verify checksum, please install sha256sum" >&2 -#fi +if command -v sha256sum; then + echo "$EIGEN_SHA256SUM $(basename "$EIGEN_URL")" \ + | sha256sum --check || exit 1 +else + echo "WARNING: could not verify checksum, please install sha256sum" >&2 +fi ./scripts/update_eigen.sh ${ARC} rm ${ARC} # patch for non-portable includes in Eigen 3.3.5 From 989af658071f5d9fc92adc0d6e0ab9775b3e0e51 Mon Sep 17 00:00:00 2001 From: Daniel Richtmann Date: Mon, 23 Mar 2020 17:33:18 +0100 Subject: [PATCH 04/36] Check in parallel reader for openqcd configs --- Grid/parallelIO/MetaData.h | 24 ++ Grid/parallelIO/OpenQcdIO.h | 165 ++++++++---- Grid/parallelIO/OpenQcdIOChromaReference.h | 281 +++++++++++++++++++++ Grid/qcd/hmc/HMC_aggregate.h | 3 + tests/IO/Test_openqcd_io.cc | 51 +++- 5 files changed, 466 insertions(+), 58 deletions(-) create mode 100644 Grid/parallelIO/OpenQcdIOChromaReference.h diff --git a/Grid/parallelIO/MetaData.h b/Grid/parallelIO/MetaData.h index 2e211838..4c1cfbdb 100644 --- a/Grid/parallelIO/MetaData.h +++ b/Grid/parallelIO/MetaData.h @@ -301,6 +301,30 @@ struct GaugeSimpleUnmunger { }; }; +template +struct GaugeDoubleStoredMunger{ + void operator()(fobj &in, sobj &out) { + for (int mu = 0; mu < Nds; mu++) { + for (int i = 0; i < Nc; i++) { + for (int j = 0; j < Nc; j++) { + out(mu)()(i, j) = in(mu)()(i, j); + }} + } + }; +}; + +template +struct GaugeDoubleStoredUnmunger { + void operator()(sobj &in, fobj &out) { + for (int mu = 0; mu < Nds; mu++) { + for (int i = 0; i < Nc; i++) { + for (int j = 0; j < Nc; j++) { + out(mu)()(i, j) = in(mu)()(i, j); + }} + } + }; +}; + template struct Gauge3x2munger{ void operator() (fobj &in,sobj &out){ diff --git a/Grid/parallelIO/OpenQcdIO.h b/Grid/parallelIO/OpenQcdIO.h index f340e8fc..00911595 100644 --- a/Grid/parallelIO/OpenQcdIO.h +++ b/Grid/parallelIO/OpenQcdIO.h @@ -67,6 +67,10 @@ public: field.dimension[2] = header.Nz; field.dimension[3] = header.Nt; + std::cout << GridLogDebug << "header: " << header << std::endl; + std::cout << GridLogDebug << "grid dimensions: " << grid->_fdimensions << std::endl; + std::cout << GridLogDebug << "file dimensions: " << field.dimension << std::endl; + assert(grid->_ndimension == Nd); for(int d = 0; d < Nd; d++) assert(grid->_fdimensions[d] == field.dimension[d]); @@ -80,74 +84,141 @@ public: static inline void readConfiguration(Lattice>& Umu, FieldMetaData& header, std::string file) { + typedef Lattice> DoubleStoredGaugeField; + + assert(Ns == 4 and Nd == 4 and Nc == 3); + auto grid = dynamic_cast(Umu.Grid()); - assert(grid != nullptr); - assert((grid->_ndimension == Nd) && (Nd == 4)); + assert(grid != nullptr); assert(grid->_ndimension == Nd); uint64_t offset = readHeader(file, Umu.Grid(), header); + FieldMetaData clone(header); - // NOTE: This version is suboptimal because we read in the full file on every rank - std::vector data(grid->gSites() * 4); - { - auto fin = std::fstream(file, std::ios::in | std::ios::binary); - fin.seekg(offset); - fin.read((char *)data.data(), data.size() * sizeof(ColourMatrix)); - fin.close(); - } + std::string format("IEEE64"); // they always store little endian double precsision + uint32_t nersc_csum, scidac_csuma, scidac_csumb; - // global lattice size - Coordinate fdim = grid->FullDimensions(); + GridCartesian* grid_openqcd = createOpenQcdGrid(grid); + GridRedBlackCartesian* grid_rb = SpaceTimeGrid::makeFourDimRedBlackGrid(grid); - // coordinate of this process - Coordinate pcoor; - grid->ProcessorCoorFromRank(CartesianCommunicator::RankWorld(), pcoor); + typedef DoubleStoredColourMatrixD fobj; + typedef typename DoubleStoredGaugeField::vector_object::scalar_object sobj; + typedef typename DoubleStoredGaugeField::vector_object::Realified::scalar_type word; - // loop over local indices - thread_for(idx, grid->lSites(), { - // convert local index to global coordinate - Coordinate lcoor, gcoor; - grid->LocalIndexToLocalCoor(idx, lcoor); - grid->ProcessorCoorLocalCoorToGlobalCoor(pcoor, lcoor, gcoor); + word w = 0; - // openQCD stores links attached to odd sites - bool neg = (gcoor[Xdir] + gcoor[Ydir] + gcoor[Zdir] + gcoor[Tdir]) % 2 != 1; + std::vector iodata(grid_openqcd->lSites()); // Munge, checksum, byte order in here + std::vector scalardata(grid->lSites()); - LorentzColourMatrix site_data; - for (int mu = 0; mu < 4; ++mu) { - // determine the site at which it is stored - Coordinate c = gcoor; - if (neg) - c[mu] = (c[mu] + 1) % grid->FullDimensions()[mu]; + IOobject(w, grid_openqcd, iodata, file, offset, format, BINARYIO_READ | BINARYIO_LEXICOGRAPHIC, + nersc_csum, scidac_csuma, scidac_csumb); - // site-index in the OpenQCD format (which uses t,x,y,z order) - int openqcd_idx = (c[Tdir] * fdim[Xdir] * fdim[Ydir] * fdim[Zdir] - + c[Xdir] * fdim[Ydir] * fdim[Zdir] - + c[Ydir] * fdim[Zdir] - + c[Zdir])/2; - int openqcd_mu = (mu + 1) % 4; + GridStopWatch timer; + timer.Start(); - // pick the colour-matrix out - site_data(mu) = - data[8 * openqcd_idx + 2 * openqcd_mu + (neg ? 1 : 0)](); - } + DoubleStoredGaugeField Umu_ds(grid); - pokeLocalSite(site_data, Umu, lcoor); + auto munge = GaugeDoubleStoredMunger(); + + Coordinate ldim = grid->LocalDimensions(); + thread_for(idx_g, grid->lSites(), { + Coordinate coor; + grid->LocalIndexToLocalCoor(idx_g, coor); + + bool isOdd = grid_rb->CheckerBoard(coor) == Odd; + + if(!isOdd) continue; + + int idx_o = (coor[Tdir] * ldim[Xdir] * ldim[Ydir] * ldim[Zdir] + + coor[Xdir] * ldim[Ydir] * ldim[Zdir] + + coor[Ydir] * ldim[Zdir] + + coor[Zdir])/2; + + munge(iodata[idx_o], scalardata[idx_g]); }); + grid->Barrier(); timer.Stop(); + std::cout << Grid::GridLogMessage << "OpenQcdIO::readConfiguration: munge overhead " << timer.Elapsed() << std::endl; + + timer.Reset(); timer.Start(); + + vectorizeFromLexOrdArray(scalardata, Umu_ds); + + grid->Barrier(); timer.Stop(); + std::cout << Grid::GridLogMessage << "OpenQcdIO::readConfiguration: vectorize overhead " << timer.Elapsed() << std::endl; + + timer.Reset(); timer.Start(); + + undoDoubleStore(Umu, Umu_ds); + + grid->Barrier(); timer.Stop(); + std::cout << Grid::GridLogMessage << "OpenQcdIO::readConfiguration: redistribute overhead " << timer.Elapsed() << std::endl; + GaugeStatistics(Umu, clone); - std::cout << GridLogMessage << "OpenQcd Configuration " << file << " plaquette " - << std::setprecision(15) - << clone.plaquette << " header " << header.plaquette - << " difference " << fabs(clone.plaquette - header.plaquette) - << std::endl; + RealD plaq_diff = fabs(clone.plaquette - header.plaquette); - if(fabs(clone.plaquette - header.plaquette) >= 1.0e-5) std::cout << " Plaquette mismatch " << std::endl; - assert(fabs(clone.plaquette - header.plaquette) < 1.0e-5); + // clang-format off + std::cout << GridLogMessage << "OpenQcd Configuration " << file + << " plaquette " << clone.plaquette + << " header " << header.plaquette + << " difference " << plaq_diff + << std::endl; + // clang-format on + + RealD precTol = (getPrecision::value == 1) ? 2e-7 : 2e-15; + RealD tol = precTol * std::sqrt(grid->_Nprocessors); // taken from RQCD chroma code + + if(plaq_diff >= tol) + std::cout << " Plaquette mismatch (diff = " << plaq_diff << ", tol = " << tol << ")" << std::endl; + assert(plaq_diff < tol); std::cout << GridLogMessage << "OpenQcd Configuration " << file << " and plaquette agree" << std::endl; } + + template + static inline void writeConfiguration(Lattice>& Umu, + std::string file) { + std::cout << GridLogError << "Writing to openQCD file format is not implemented" << std::endl; + exit(EXIT_FAILURE); + } + +private: + static inline GridCartesian* createOpenQcdGrid(GridCartesian* grid) { + // exploit GridCartesian to be able to still use IOobject + Coordinate gdim = grid->GlobalDimensions(); + Coordinate ldim = grid->LocalDimensions(); + Coordinate pcoor = grid->ThisProcessorCoor(); + + // openqcd does rb on the z direction + gdim[Zdir] /= 2; + ldim[Zdir] /= 2; + + // and has the order T X Y Z (from slowest to fastest) + std::swap(gdim[Xdir], gdim[Zdir]); + std::swap(ldim[Xdir], ldim[Zdir]); + std::swap(pcoor[Xdir], pcoor[Zdir]); + + GridCartesian* ret = SpaceTimeGrid::makeFourDimGrid(gdim, grid->_simd_layout, grid->ProcessorGrid()); + ret->_ldimensions = ldim; + ret->_processor_coor = pcoor; + return ret; + } + + template + static inline void undoDoubleStore(Lattice>& Umu, + Lattice> const& Umu_ds) { + conformable(Umu.Grid(), Umu_ds.Grid()); + Lattice> U(Umu.Grid()); + + // they store T+, T-, X+, X-, Y+, Y-, Z+, Z- + for(int mu_g = 0; mu_g < Nd; ++mu_g) { + int mu_o = (mu_g + 1) % Nd; + U = PeekIndex(Umu_ds, 2 * mu_o) + + Cshift(PeekIndex(Umu_ds, 2 * mu_o + 1), mu_g, +1); + PokeIndex(Umu, U, mu_g); + } + } }; NAMESPACE_END(Grid); diff --git a/Grid/parallelIO/OpenQcdIOChromaReference.h b/Grid/parallelIO/OpenQcdIOChromaReference.h new file mode 100644 index 00000000..bab54fe8 --- /dev/null +++ b/Grid/parallelIO/OpenQcdIOChromaReference.h @@ -0,0 +1,281 @@ +/************************************************************************************* + +Grid physics library, www.github.com/paboyle/Grid + +Source file: ./lib/parallelIO/OpenQcdIOChromaReference.h + +Copyright (C) 2015 - 2020 + +Author: Daniel Richtmann + +This program is free software; you can redistribute it and/or modify +it under the terms of the GNU General Public License as published by +the Free Software Foundation; either version 2 of the License, or +(at your option) any later version. + +This program is distributed in the hope that it will be useful, +but WITHOUT ANY WARRANTY; without even the implied warranty of +MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the +GNU General Public License for more details. + +You should have received a copy of the GNU General Public License along +with this program; if not, write to the Free Software Foundation, Inc., +51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. + +See the full license in the file "LICENSE" in the top level distribution +directory +*************************************************************************************/ +/* END LEGAL */ +#pragma once + +#include +#include +#include +#include +#include +#include +#include + +#define CHECK {std::cerr << __FILE__ << " @l " << __LINE__ << ": CHECK" << grid->ThisRank() << std::endl;} +#define CHECK_VAR(a) { std::cerr << __FILE__ << "@l" << __LINE__ << " on "<< grid->ThisRank() << ": " << __func__ << " " << #a << "=" << (a) << std::endl; } +// #undef CHECK +// #define CHECK + +NAMESPACE_BEGIN(Grid); + +class ParRdr { +private: + bool const swap; + + MPI_Status status; + MPI_File fp; + + int err; + + MPI_Datatype oddSiteType; + MPI_Datatype fileViewType; + + GridBase* grid; + +public: + ParRdr(MPI_Comm comm, std::string const& filename, GridBase* gridPtr) + : swap(false) + , grid(gridPtr) { + err = MPI_File_open(comm, const_cast(filename.c_str()), MPI_MODE_RDONLY, MPI_INFO_NULL, &fp); + assert(err == MPI_SUCCESS); + } + + virtual ~ParRdr() { MPI_File_close(&fp); } + + inline void errInfo(int const err, std::string const& func) { + static char estring[MPI_MAX_ERROR_STRING]; + int eclass = -1, len = 0; + MPI_Error_class(err, &eclass); + MPI_Error_string(err, estring, &len); + std::cerr << func << " - Error " << eclass << ": " << estring << std::endl; + } + + int readHeader(FieldMetaData& field) { + assert((grid->_ndimension == Nd) && (Nd == 4)); + assert(Nc == 3); + + OpenQcdHeader header; + + readBlock(reinterpret_cast(&header), 0, sizeof(OpenQcdHeader), MPI_CHAR); + + header.plaq /= 3.; // TODO change this into normalizationfactor + + // sanity check (should trigger on endian issues) TODO remove? + assert(0 < header.Nt && header.Nt <= 1024); + assert(0 < header.Nx && header.Nx <= 1024); + assert(0 < header.Ny && header.Ny <= 1024); + assert(0 < header.Nz && header.Nz <= 1024); + + field.dimension[0] = header.Nx; + field.dimension[1] = header.Ny; + field.dimension[2] = header.Nz; + field.dimension[3] = header.Nt; + + for(int d = 0; d < Nd; d++) + assert(grid->FullDimensions()[d] == field.dimension[d]); + + field.plaquette = header.plaq; + + field.data_start = sizeof(OpenQcdHeader); + + return field.data_start; + } + + void readBlock(void* const dest, uint64_t const pos, uint64_t const nbytes, MPI_Datatype const datatype) { + err = MPI_File_read_at_all(fp, pos, dest, nbytes, datatype, &status); + errInfo(err, "MPI_File_read_at_all"); + // CHECK_VAR(err) + + int read = -1; + MPI_Get_count(&status, datatype, &read); + // CHECK_VAR(read) + assert(nbytes == (uint64_t)read); + assert(err == MPI_SUCCESS); + } + + void createTypes() { + constexpr int elem_size = Nd * 2 * 2 * Nc * Nc * sizeof(double); // 2_complex 2_fwdbwd + + err = MPI_Type_contiguous(elem_size, MPI_BYTE, &oddSiteType); assert(err == MPI_SUCCESS); + err = MPI_Type_commit(&oddSiteType); assert(err == MPI_SUCCESS); + + Coordinate const L = grid->GlobalDimensions(); + Coordinate const l = grid->LocalDimensions(); + Coordinate const i = grid->ThisProcessorCoor(); + + Coordinate sizes({L[2] / 2, L[1], L[0], L[3]}); + Coordinate subsizes({l[2] / 2, l[1], l[0], l[3]}); + Coordinate starts({i[2] * l[2] / 2, i[1] * l[1], i[0] * l[0], i[3] * l[3]}); + + err = MPI_Type_create_subarray(grid->_ndimension, &sizes[0], &subsizes[0], &starts[0], MPI_ORDER_FORTRAN, oddSiteType, &fileViewType); assert(err == MPI_SUCCESS); + err = MPI_Type_commit(&fileViewType); assert(err == MPI_SUCCESS); + } + + void freeTypes() { + err = MPI_Type_free(&fileViewType); assert(err == MPI_SUCCESS); + err = MPI_Type_free(&oddSiteType); assert(err == MPI_SUCCESS); + } + + bool readGauge(std::vector& domain_buff, FieldMetaData& meta) { + auto hdr_offset = readHeader(meta); + CHECK + createTypes(); + err = MPI_File_set_view(fp, hdr_offset, oddSiteType, fileViewType, "native", MPI_INFO_NULL); errInfo(err, "MPI_File_set_view0"); assert(err == MPI_SUCCESS); + CHECK + int const domainSites = grid->lSites(); + domain_buff.resize(Nd * domainSites); // 2_fwdbwd * 4_Nd * domainSites / 2_onlyodd + + // the actual READ + constexpr uint64_t cm_size = 2 * Nc * Nc * sizeof(double); // 2_complex + constexpr uint64_t os_size = Nd * 2 * cm_size; // 2_fwdbwd + constexpr uint64_t max_elems = std::numeric_limits::max(); // int adressable elems: floor is fine + uint64_t const n_os = domainSites / 2; + + for(uint64_t os_idx = 0; os_idx < n_os;) { + uint64_t const read_os = os_idx + max_elems <= n_os ? max_elems : n_os - os_idx; + uint64_t const cm = os_idx * Nd * 2; + readBlock(&(domain_buff[cm]), os_idx, read_os, oddSiteType); + os_idx += read_os; + } + + CHECK + err = MPI_File_set_view(fp, 0, MPI_BYTE, MPI_BYTE, "native", MPI_INFO_NULL); + errInfo(err, "MPI_File_set_view1"); + assert(err == MPI_SUCCESS); + freeTypes(); + + std::cout << GridLogMessage << "read sum: " << n_os * os_size << " bytes" << std::endl; + return true; + } +}; + +class OpenQcdIOChromaReference : public BinaryIO { +public: + template + static inline void readConfiguration(Lattice>& Umu, + Grid::FieldMetaData& header, + std::string file) { + typedef Lattice> DoubledGaugeField; + + assert(Ns == 4 and Nd == 4 and Nc == 3); + + auto grid = Umu.Grid(); + + typedef ColourMatrixD fobj; + + std::vector iodata( + Nd * grid->lSites()); // actual size = 2*Nd*lsites but have only lsites/2 sites in file + + { + ParRdr rdr(MPI_COMM_WORLD, file, grid); + rdr.readGauge(iodata, header); + } // equivalent to using binaryio + + std::vector> Umu_ds_scalar(grid->lSites()); + + copyToLatticeObject(Umu_ds_scalar, iodata, grid); // equivalent to munging + + DoubledGaugeField Umu_ds(grid); + + vectorizeFromLexOrdArray(Umu_ds_scalar, Umu_ds); + + redistribute(Umu, Umu_ds); // equivalent to undoDoublestore + + FieldMetaData clone(header); + + GaugeStatistics(Umu, clone); + + RealD plaq_diff = fabs(clone.plaquette - header.plaquette); + + // clang-format off + std::cout << GridLogMessage << "OpenQcd Configuration " << file + << " plaquette " << clone.plaquette + << " header " << header.plaquette + << " difference " << plaq_diff + << std::endl; + // clang-format on + + RealD precTol = (getPrecision::value == 1) ? 2e-7 : 2e-15; + RealD tol = precTol * std::sqrt(grid->_Nprocessors); // taken from RQCD chroma code + + if(plaq_diff >= tol) + std::cout << " Plaquette mismatch (diff = " << plaq_diff << ", tol = " << tol << ")" << std::endl; + assert(plaq_diff < tol); + + std::cout << GridLogMessage << "OpenQcd Configuration " << file << " and plaquette agree" << std::endl; + } + +private: + template + static inline void redistribute(Lattice>& Umu, + Lattice> const& Umu_ds) { + Grid::conformable(Umu.Grid(), Umu_ds.Grid()); + Lattice> U(Umu.Grid()); + + U = PeekIndex(Umu_ds, 2) + Cshift(PeekIndex(Umu_ds, 3), 0, +1); PokeIndex(Umu, U, 0); + U = PeekIndex(Umu_ds, 4) + Cshift(PeekIndex(Umu_ds, 5), 1, +1); PokeIndex(Umu, U, 1); + U = PeekIndex(Umu_ds, 6) + Cshift(PeekIndex(Umu_ds, 7), 2, +1); PokeIndex(Umu, U, 2); + U = PeekIndex(Umu_ds, 0) + Cshift(PeekIndex(Umu_ds, 1), 3, +1); PokeIndex(Umu, U, 3); + } + + static inline void copyToLatticeObject(std::vector& u_fb, + std::vector const& node_buff, + GridBase* grid) { + assert(node_buff.size() == Nd * grid->lSites()); + + Coordinate const& l = grid->LocalDimensions(); + + Coordinate coord(Nd); + int& x = coord[0]; + int& y = coord[1]; + int& z = coord[2]; + int& t = coord[3]; + + int buff_idx = 0; + for(t = 0; t < l[3]; ++t) // IMPORTANT: openQCD file ordering + for(x = 0; x < l[0]; ++x) + for(y = 0; y < l[1]; ++y) + for(z = 0; z < l[2]; ++z) { + if((t + z + y + x) % 2 == 0) continue; + + int local_idx; + Lexicographic::IndexFromCoor(coord, local_idx, grid->LocalDimensions()); + for(int mu = 0; mu < 2 * Nd; ++mu) + for(int c1 = 0; c1 < Nc; ++c1) { + for(int c2 = 0; c2 < Nc; ++c2) { + u_fb[local_idx](mu)()(c1,c2) = node_buff[mu+buff_idx]()()(c1,c2); + } + } + buff_idx += 2 * Nd; + } + + assert(node_buff.size() == buff_idx); + } +}; + +NAMESPACE_END(Grid); diff --git a/Grid/qcd/hmc/HMC_aggregate.h b/Grid/qcd/hmc/HMC_aggregate.h index 94c745e1..cb510953 100644 --- a/Grid/qcd/hmc/HMC_aggregate.h +++ b/Grid/qcd/hmc/HMC_aggregate.h @@ -40,6 +40,9 @@ directory #include #include #include +#if !defined(GRID_COMMS_NONE) +#include +#endif NAMESPACE_CHECK(Ildg); #include diff --git a/tests/IO/Test_openqcd_io.cc b/tests/IO/Test_openqcd_io.cc index 2a5769bd..83b498c2 100644 --- a/tests/IO/Test_openqcd_io.cc +++ b/tests/IO/Test_openqcd_io.cc @@ -28,28 +28,57 @@ See the full license in the file "LICENSE" in the top level distribution directo #include +#if defined(GRID_COMMS_NONE) +#error This test requires Grid compiled with MPI +#endif + using namespace Grid; int main(int argc, char** argv) { Grid_init(&argc, &argv); - GridCartesian* grid = SpaceTimeGrid::makeFourDimGrid(GridDefaultLatt(), - GridDefaultSimd(Nd, vComplexD::Nsimd()), - GridDefaultMpi()); + auto simd_layout = GridDefaultSimd(Nd, vComplex::Nsimd()); + auto mpi_layout = GridDefaultMpi(); + auto latt_size = GridDefaultLatt(); - LatticeGaugeField Umu(grid); + GridCartesian grid(latt_size, simd_layout, mpi_layout); - FieldMetaData header; + GridParallelRNG pRNG(&grid); - if(!Grid::GridCmdOptionExists(argv, argv + argc, "--config")) { - std::cout << GridLogError << "You need to use --config /path/to/openqcd_config" << std::endl; - abort(); + pRNG.SeedFixedIntegers(std::vector({45, 12, 81, 9})); + + LatticeGaugeField Umu_ref(&grid); + LatticeGaugeField Umu_me(&grid); + LatticeGaugeField Umu_diff(&grid); + + FieldMetaData header_ref; + FieldMetaData header_me; + + Umu_ref = Zero(); + Umu_me = Zero(); + + std::string file("/home/daniel/configs/openqcd/test_16x8_pbcn6"); + + if(GridCmdOptionExists(argv, argv + argc, "--config")) { + file = GridCmdOptionPayload(argv, argv + argc, "--config"); + std::cout << "file: " << file << std::endl; + assert(!file.empty()); } - std::string file = Grid::GridCmdOptionPayload(argv, argv + argc, "--config"); - assert(!file.empty()); + OpenQcdIOChromaReference::readConfiguration(Umu_ref, header_ref, file); + OpenQcdIO::readConfiguration(Umu_me, header_me, file); - OpenQcdIO::readConfiguration(Umu, header, file); + std::cout << GridLogMessage << header_ref << std::endl; + std::cout << GridLogMessage << header_me << std::endl; + + Umu_diff = Umu_ref - Umu_me; + + // clang-format off + std::cout << GridLogMessage + << "norm2(Umu_ref) = " << norm2(Umu_ref) + << " norm2(Umu_me) = " << norm2(Umu_me) + << " norm2(Umu_diff) = " << norm2(Umu_diff) << std::endl; + // clang-format on Grid_finalize(); } From a2188ea875246e16d2081142a62e59f85961a6c4 Mon Sep 17 00:00:00 2001 From: Christoph Lehner Date: Thu, 26 Mar 2020 09:12:36 -0400 Subject: [PATCH 05/36] remove debugging printf from WilsonKernelsImplementation --- .../fermion/implementation/WilsonKernelsImplementation.h | 6 +++--- 1 file changed, 3 insertions(+), 3 deletions(-) diff --git a/Grid/qcd/action/fermion/implementation/WilsonKernelsImplementation.h b/Grid/qcd/action/fermion/implementation/WilsonKernelsImplementation.h index a787fa79..5600d25a 100644 --- a/Grid/qcd/action/fermion/implementation/WilsonKernelsImplementation.h +++ b/Grid/qcd/action/fermion/implementation/WilsonKernelsImplementation.h @@ -372,19 +372,19 @@ void WilsonKernels::DhopKernel(int Opt,StencilImpl &st, DoubledGaugeField if (Opt == WilsonKernelsStatic::OptGeneric ) { KERNEL_CALL(GenericDhopSite); return;} #ifndef GRID_NVCC if (Opt == WilsonKernelsStatic::OptHandUnroll ) { KERNEL_CALL(HandDhopSite); return;} - if (Opt == WilsonKernelsStatic::OptInlineAsm ) { ASM_CALL(AsmDhopSite); printf("."); return;} + if (Opt == WilsonKernelsStatic::OptInlineAsm ) { ASM_CALL(AsmDhopSite); return;} #endif } else if( interior ) { if (Opt == WilsonKernelsStatic::OptGeneric ) { KERNEL_CALLNB(GenericDhopSiteInt); return;} #ifndef GRID_NVCC if (Opt == WilsonKernelsStatic::OptHandUnroll ) { KERNEL_CALLNB(HandDhopSiteInt); return;} - if (Opt == WilsonKernelsStatic::OptInlineAsm ) { ASM_CALL(AsmDhopSiteInt); printf("-"); return;} + if (Opt == WilsonKernelsStatic::OptInlineAsm ) { ASM_CALL(AsmDhopSiteInt); return;} #endif } else if( exterior ) { if (Opt == WilsonKernelsStatic::OptGeneric ) { KERNEL_CALL(GenericDhopSiteExt); return;} #ifndef GRID_NVCC if (Opt == WilsonKernelsStatic::OptHandUnroll ) { KERNEL_CALL(HandDhopSiteExt); return;} - if (Opt == WilsonKernelsStatic::OptInlineAsm ) { ASM_CALL(AsmDhopSiteExt); printf("+"); return;} + if (Opt == WilsonKernelsStatic::OptInlineAsm ) { ASM_CALL(AsmDhopSiteExt); return;} #endif } assert(0 && " Kernel optimisation case not covered "); From 856d168e4131b915ecab245753b44b690662c881 Mon Sep 17 00:00:00 2001 From: Christoph Lehner Date: Sun, 29 Mar 2020 07:56:05 -0400 Subject: [PATCH 06/36] global sum over vectors of uint64_t --- Grid/communicator/Communicator_base.h | 1 + Grid/communicator/Communicator_mpi3.cc | 4 ++++ Grid/communicator/Communicator_none.cc | 3 ++- 3 files changed, 7 insertions(+), 1 deletion(-) diff --git a/Grid/communicator/Communicator_base.h b/Grid/communicator/Communicator_base.h index 11dbfcbb..436d75ef 100644 --- a/Grid/communicator/Communicator_base.h +++ b/Grid/communicator/Communicator_base.h @@ -114,6 +114,7 @@ public: void GlobalSumVector(RealD *,int N); void GlobalSum(uint32_t &); void GlobalSum(uint64_t &); + void GlobalSumVector(uint64_t*,int N); void GlobalSum(ComplexF &c); void GlobalSumVector(ComplexF *c,int N); void GlobalSum(ComplexD &c); diff --git a/Grid/communicator/Communicator_mpi3.cc b/Grid/communicator/Communicator_mpi3.cc index 2576b1fa..0e525674 100644 --- a/Grid/communicator/Communicator_mpi3.cc +++ b/Grid/communicator/Communicator_mpi3.cc @@ -255,6 +255,10 @@ void CartesianCommunicator::GlobalSum(uint64_t &u){ int ierr=MPI_Allreduce(MPI_IN_PLACE,&u,1,MPI_UINT64_T,MPI_SUM,communicator); assert(ierr==0); } +void CartesianCommunicator::GlobalSumVector(uint64_t* u,int N){ + int ierr=MPI_Allreduce(MPI_IN_PLACE,u,N,MPI_UINT64_T,MPI_SUM,communicator); + assert(ierr==0); +} void CartesianCommunicator::GlobalXOR(uint32_t &u){ int ierr=MPI_Allreduce(MPI_IN_PLACE,&u,1,MPI_UINT32_T,MPI_BXOR,communicator); assert(ierr==0); diff --git a/Grid/communicator/Communicator_none.cc b/Grid/communicator/Communicator_none.cc index b8a15a0e..81900371 100644 --- a/Grid/communicator/Communicator_none.cc +++ b/Grid/communicator/Communicator_none.cc @@ -70,9 +70,10 @@ CartesianCommunicator::~CartesianCommunicator(){} void CartesianCommunicator::GlobalSum(float &){} void CartesianCommunicator::GlobalSumVector(float *,int N){} void CartesianCommunicator::GlobalSum(double &){} +void CartesianCommunicator::GlobalSumVector(double *,int N){} void CartesianCommunicator::GlobalSum(uint32_t &){} void CartesianCommunicator::GlobalSum(uint64_t &){} -void CartesianCommunicator::GlobalSumVector(double *,int N){} +void CartesianCommunicator::GlobalSumVector(uint64_t *,int N){} void CartesianCommunicator::GlobalXOR(uint32_t &){} void CartesianCommunicator::GlobalXOR(uint64_t &){} From 5fc8a273e7e8f1a29acebad0237b5e0bef2ecb97 Mon Sep 17 00:00:00 2001 From: Daniel Richtmann Date: Mon, 6 Apr 2020 11:30:50 +0200 Subject: [PATCH 07/36] Fused innerProduct + norm2 on first argument operation --- Grid/lattice/Lattice_reduction.h | 58 +++++++++++++- tests/Test_innerproduct_norm.cc | 126 +++++++++++++++++++++++++++++++ 2 files changed, 183 insertions(+), 1 deletion(-) create mode 100644 tests/Test_innerproduct_norm.cc diff --git a/Grid/lattice/Lattice_reduction.h b/Grid/lattice/Lattice_reduction.h index 3c5b03e5..de2efd72 100644 --- a/Grid/lattice/Lattice_reduction.h +++ b/Grid/lattice/Lattice_reduction.h @@ -204,8 +204,64 @@ axpby_norm_fast(Lattice &z,sobj a,sobj b,const Lattice &x,const Latt grid->GlobalSum(nrm); return nrm; } - +template strong_inline void +innerProduct_norm(ComplexD& ip, RealD &nrm, const Lattice &left,const Lattice &right) +{ + conformable(left,right); + + typedef typename vobj::scalar_type scalar_type; + typedef typename vobj::vector_typeD vector_type; + Vector tmp(2); + + GridBase *grid = left.Grid(); + + auto left_v=left.View(); + auto right_v=right.View(); + + const uint64_t nsimd = grid->Nsimd(); + const uint64_t sites = grid->oSites(); + +#ifdef GRID_NVCC + // GPU + typedef decltype(innerProduct(left_v[0],right_v[0])) inner_t; + typedef decltype(innerProduct(left_v[0],left_v[0])) norm_t; + Vector inner_tmp(sites); + Vector norm_tmp(sites); + auto inner_tmp_v = &inner_tmp[0]; + auto norm_tmp_v = &norm_tmp[0]; + + accelerator_for( ss, sites, nsimd,{ + auto left_tmp = left_v(ss); + coalescedWrite(inner_tmp_v[ss],innerProduct(left_tmp,right_v(ss))); + coalescedWrite(norm_tmp_v[ss],innerProduct(left_tmp,left_tmp))); + }); + + tmp[0] = TensorRemove(sumD_gpu(inner_tmp_v,sites)); + tmp[1] = TensorRemove(sumD_gpu(norm_tmp_v,sites)); +#else + // CPU + typedef decltype(innerProductD(left_v[0],right_v[0])) inner_t; + typedef decltype(innerProductD(left_v[0],left_v[0])) norm_t; + Vector inner_tmp(sites); + Vector norm_tmp(sites); + auto inner_tmp_v = &inner_tmp[0]; + auto norm_tmp_v = &norm_tmp[0]; + + accelerator_for( ss, sites, nsimd,{ + auto left_tmp = left_v(ss); + inner_tmp_v[ss] = innerProductD(left_tmp,right_v(ss)); + norm_tmp_v[ss] = innerProductD(left_tmp,left_tmp); + }); + // Already promoted to double + tmp[0] = TensorRemove(sum(inner_tmp_v,sites)); + tmp[1] = TensorRemove(sum(norm_tmp_v,sites)); +#endif + grid->GlobalSumVector(&tmp[0],2); // keep norm Complex -> can use GlobalSumVector + ip = tmp[0]; + nrm = real(tmp[1]); +} + template inline auto sum(const LatticeUnaryExpression & expr) ->typename decltype(expr.op.func(eval(0,expr.arg1)))::scalar_object diff --git a/tests/Test_innerproduct_norm.cc b/tests/Test_innerproduct_norm.cc new file mode 100644 index 00000000..85c98521 --- /dev/null +++ b/tests/Test_innerproduct_norm.cc @@ -0,0 +1,126 @@ +/************************************************************************************* + +Grid physics library, www.github.com/paboyle/Grid + +Source file: ./tests/Test_innerproduct_norm.cc + +Copyright (C) 2015 + +Author: Daniel Richtmann + +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 + +using namespace Grid; + +int main(int argc, char** argv) { + Grid_init(&argc, &argv); + + const int nIter = 100; + + // clang-format off + GridCartesian *Grid_d = SpaceTimeGrid::makeFourDimGrid(GridDefaultLatt(), GridDefaultSimd(Nd, vComplexD::Nsimd()), GridDefaultMpi()); + GridCartesian *Grid_f = SpaceTimeGrid::makeFourDimGrid(GridDefaultLatt(), GridDefaultSimd(Nd, vComplexF::Nsimd()), GridDefaultMpi()); + // clang-format on + + GridParallelRNG pRNG_d(Grid_d); + GridParallelRNG pRNG_f(Grid_f); + + std::vector seeds_d({1, 2, 3, 4}); + std::vector seeds_f({5, 6, 7, 8}); + + pRNG_d.SeedFixedIntegers(seeds_d); + pRNG_f.SeedFixedIntegers(seeds_f); + + // clang-format off + LatticeFermionD x_d(Grid_d); random(pRNG_d, x_d); + LatticeFermionD y_d(Grid_d); random(pRNG_d, y_d); + LatticeFermionF x_f(Grid_f); random(pRNG_f, x_f); + LatticeFermionF y_f(Grid_f); random(pRNG_f, y_f); + // clang-format on + + GridStopWatch sw_ref; + GridStopWatch sw_res; + + { // double precision + ComplexD ip_d_ref, ip_d_res, diff_ip_d; + RealD norm2_d_ref, norm2_d_res, diff_norm2_d; + + sw_ref.Reset(); + sw_ref.Start(); + for(int i = 0; i < nIter; ++i) { + ip_d_ref = innerProduct(x_d, y_d); + norm2_d_ref = norm2(x_d); + } + sw_ref.Stop(); + + sw_res.Reset(); + sw_res.Start(); + for(int i = 0; i < nIter; ++i) { innerProduct_norm(ip_d_res, norm2_d_res, x_d, y_d); } + sw_res.Stop(); + + diff_ip_d = ip_d_ref - ip_d_res; + diff_norm2_d = norm2_d_ref - norm2_d_res; + + // clang-format off + std::cout << GridLogMessage << "Double: ip_ref = " << ip_d_ref << " ip_res = " << ip_d_res << " diff = " << diff_ip_d << std::endl; + std::cout << GridLogMessage << "Double: norm2_ref = " << norm2_d_ref << " norm2_res = " << norm2_d_res << " diff = " << diff_norm2_d << std::endl; + std::cout << GridLogMessage << "Double: time_ref = " << sw_ref.Elapsed() << " time_res = " << sw_res.Elapsed() << std::endl; + // clang-format on + + assert(diff_ip_d == 0.); + assert(diff_norm2_d == 0.); + + std::cout << GridLogMessage << "Double: all checks passed" << std::endl; + } + + { // single precision + ComplexD ip_f_ref, ip_f_res, diff_ip_f; + RealD norm2_f_ref, norm2_f_res, diff_norm2_f; + + sw_ref.Reset(); + sw_ref.Start(); + for(int i = 0; i < nIter; ++i) { + ip_f_ref = innerProduct(x_f, y_f); + norm2_f_ref = norm2(x_f); + } + sw_ref.Stop(); + + sw_res.Reset(); + sw_res.Start(); + for(int i = 0; i < nIter; ++i) { innerProduct_norm(ip_f_res, norm2_f_res, x_f, y_f); } + sw_res.Stop(); + + diff_ip_f = ip_f_ref - ip_f_res; + diff_norm2_f = norm2_f_ref - norm2_f_res; + + // clang-format off + std::cout << GridLogMessage << "Single: ip_ref = " << ip_f_ref << " ip_res = " << ip_f_res << " diff = " << diff_ip_f << std::endl; + std::cout << GridLogMessage << "Single: norm2_ref = " << norm2_f_ref << " norm2_res = " << norm2_f_res << " diff = " << diff_norm2_f << std::endl; + std::cout << GridLogMessage << "Single: time_ref = " << sw_ref.Elapsed() << " time_res = " << sw_res.Elapsed() << std::endl; + // clang-format on + + assert(diff_ip_f == 0.); + assert(diff_norm2_f == 0.); + + std::cout << GridLogMessage << "Single: all checks passed" << std::endl; + } + + Grid_finalize(); +} From 091d5c605ef041dbb95ba88e8a8b49c8a7b966af Mon Sep 17 00:00:00 2001 From: Christoph Lehner Date: Fri, 17 Apr 2020 04:25:28 -0400 Subject: [PATCH 08/36] towards more precise blocking --- Grid/lattice/Lattice_reduction.h | 2 +- Grid/tensors/Tensor_class.h | 2 + Grid/tensors/Tensor_inner.h | 73 ++++++++++++++++++++++++++++++++ Grid/tensors/Tensor_traits.h | 20 +++++++++ 4 files changed, 96 insertions(+), 1 deletion(-) diff --git a/Grid/lattice/Lattice_reduction.h b/Grid/lattice/Lattice_reduction.h index de2efd72..d3f5f9ae 100644 --- a/Grid/lattice/Lattice_reduction.h +++ b/Grid/lattice/Lattice_reduction.h @@ -206,7 +206,7 @@ axpby_norm_fast(Lattice &z,sobj a,sobj b,const Lattice &x,const Latt } template strong_inline void -innerProduct_norm(ComplexD& ip, RealD &nrm, const Lattice &left,const Lattice &right) +innerProductNorm(ComplexD& ip, RealD &nrm, const Lattice &left,const Lattice &right) { conformable(left,right); diff --git a/Grid/tensors/Tensor_class.h b/Grid/tensors/Tensor_class.h index 75e42721..dbcbae8d 100644 --- a/Grid/tensors/Tensor_class.h +++ b/Grid/tensors/Tensor_class.h @@ -6,6 +6,7 @@ Copyright (C) 2015 Author: Azusa Yamaguchi Author: Peter Boyle Author: Michael Marshall +Author: Christoph Lehner 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 @@ -55,6 +56,7 @@ class GridTensorBase {}; using Complexified = typename Traits::Complexified; \ using Realified = typename Traits::Realified; \ using DoublePrecision = typename Traits::DoublePrecision; \ + using DoublePrecision2= typename Traits::DoublePrecision2; \ static constexpr int TensorLevel = Traits::TensorLevel template diff --git a/Grid/tensors/Tensor_inner.h b/Grid/tensors/Tensor_inner.h index 03f72966..c052adcf 100644 --- a/Grid/tensors/Tensor_inner.h +++ b/Grid/tensors/Tensor_inner.h @@ -8,6 +8,7 @@ Author: Azusa Yamaguchi Author: Peter Boyle +Author: Christoph Lehner 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 @@ -194,6 +195,78 @@ auto innerProductD (const iScalar& lhs,const iScalar& rhs) -> iScalar accelerator_inline + auto innerProductD2 (const iVector& lhs,const iVector& rhs) -> iScalar +{ + typedef decltype(innerProductD2(lhs._internal[0],rhs._internal[0])) ret_t; + iScalar ret; + zeroit(ret); + for(int c1=0;c1 accelerator_inline + auto innerProductD2 (const iMatrix& lhs,const iMatrix& rhs) -> iScalar +{ + typedef decltype(innerProductD2(lhs._internal[0][0],rhs._internal[0][0])) ret_t; + iScalar ret; + ret=Zero(); + for(int c1=0;c1 accelerator_inline + auto innerProductD2 (const iScalar& lhs,const iScalar& rhs) -> iScalar +{ + typedef decltype(innerProductD2(lhs._internal,rhs._internal)) ret_t; + iScalar ret; + ret._internal = innerProductD2(lhs._internal,rhs._internal); + return ret; +} + ////////////////////// // Keep same precison ////////////////////// diff --git a/Grid/tensors/Tensor_traits.h b/Grid/tensors/Tensor_traits.h index 9067d43d..afb1f916 100644 --- a/Grid/tensors/Tensor_traits.h +++ b/Grid/tensors/Tensor_traits.h @@ -6,6 +6,7 @@ Author: Azusa Yamaguchi Author: Peter Boyle Author: Christopher Kelly Author: Michael Marshall +Author: Christoph Lehner 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 @@ -37,6 +38,10 @@ NAMESPACE_BEGIN(Grid); template struct isGridTensor> : public std::true_type { static constexpr bool notvalue = false; }; template struct isGridTensor> : public std::true_type { static constexpr bool notvalue = false; }; + // To store double-precision data in single-precision grids for precision promoted localInnerProductD + typedef iVector vComplexD2; + typedef iVector vRealD2; + ////////////////////////////////////////////////////////////////////////////////// // Want to recurse: GridTypeMapper >::scalar_type == ComplexD. // Use of a helper class like this allows us to template specialise and "dress" @@ -81,6 +86,7 @@ NAMESPACE_BEGIN(Grid); typedef ComplexF Complexified; typedef RealF Realified; typedef RealD DoublePrecision; + typedef RealD DoublePrecision2; }; template<> struct GridTypeMapper : public GridTypeMapper_Base { typedef RealD scalar_type; @@ -93,6 +99,7 @@ NAMESPACE_BEGIN(Grid); typedef ComplexD Complexified; typedef RealD Realified; typedef RealD DoublePrecision; + typedef RealD DoublePrecision2; }; template<> struct GridTypeMapper : public GridTypeMapper_Base { typedef ComplexF scalar_type; @@ -105,6 +112,7 @@ NAMESPACE_BEGIN(Grid); typedef ComplexF Complexified; typedef RealF Realified; typedef ComplexD DoublePrecision; + typedef ComplexD DoublePrecision2; }; template<> struct GridTypeMapper : public GridTypeMapper_Base { typedef ComplexD scalar_type; @@ -117,6 +125,7 @@ NAMESPACE_BEGIN(Grid); typedef ComplexD Complexified; typedef RealD Realified; typedef ComplexD DoublePrecision; + typedef ComplexD DoublePrecision2; }; template<> struct GridTypeMapper : public GridTypeMapper_Base { typedef Integer scalar_type; @@ -129,6 +138,7 @@ NAMESPACE_BEGIN(Grid); typedef void Complexified; typedef void Realified; typedef void DoublePrecision; + typedef void DoublePrecision2; }; template<> struct GridTypeMapper : public GridTypeMapper_Base { @@ -142,6 +152,7 @@ NAMESPACE_BEGIN(Grid); typedef vComplexF Complexified; typedef vRealF Realified; typedef vRealD DoublePrecision; + typedef vRealD2 DoublePrecision2; }; template<> struct GridTypeMapper : public GridTypeMapper_Base { typedef RealD scalar_type; @@ -154,6 +165,7 @@ NAMESPACE_BEGIN(Grid); typedef vComplexD Complexified; typedef vRealD Realified; typedef vRealD DoublePrecision; + typedef vRealD DoublePrecision2; }; template<> struct GridTypeMapper : public GridTypeMapper_Base { // Fixme this is incomplete until Grid supports fp16 or bfp16 arithmetic types @@ -167,6 +179,7 @@ NAMESPACE_BEGIN(Grid); typedef vComplexH Complexified; typedef vRealH Realified; typedef vRealD DoublePrecision; + typedef vRealD DoublePrecision2; }; template<> struct GridTypeMapper : public GridTypeMapper_Base { // Fixme this is incomplete until Grid supports fp16 or bfp16 arithmetic types @@ -180,6 +193,7 @@ NAMESPACE_BEGIN(Grid); typedef vComplexH Complexified; typedef vRealH Realified; typedef vComplexD DoublePrecision; + typedef vComplexD DoublePrecision2; }; template<> struct GridTypeMapper : public GridTypeMapper_Base { typedef ComplexF scalar_type; @@ -192,6 +206,7 @@ NAMESPACE_BEGIN(Grid); typedef vComplexF Complexified; typedef vRealF Realified; typedef vComplexD DoublePrecision; + typedef vComplexD2 DoublePrecision2; }; template<> struct GridTypeMapper : public GridTypeMapper_Base { typedef ComplexD scalar_type; @@ -204,6 +219,7 @@ NAMESPACE_BEGIN(Grid); typedef vComplexD Complexified; typedef vRealD Realified; typedef vComplexD DoublePrecision; + typedef vComplexD DoublePrecision2; }; template<> struct GridTypeMapper : public GridTypeMapper_Base { typedef Integer scalar_type; @@ -216,6 +232,7 @@ NAMESPACE_BEGIN(Grid); typedef void Complexified; typedef void Realified; typedef void DoublePrecision; + typedef void DoublePrecision2; }; #define GridTypeMapper_RepeatedTypes \ @@ -234,6 +251,7 @@ NAMESPACE_BEGIN(Grid); using Complexified = iScalar; using Realified = iScalar; using DoublePrecision = iScalar; + using DoublePrecision2= iScalar; static constexpr int Rank = BaseTraits::Rank + 1; static constexpr std::size_t count = BaseTraits::count; static constexpr int Dimension(int dim) { @@ -248,6 +266,7 @@ NAMESPACE_BEGIN(Grid); using Complexified = iVector; using Realified = iVector; using DoublePrecision = iVector; + using DoublePrecision2= iVector; static constexpr int Rank = BaseTraits::Rank + 1; static constexpr std::size_t count = BaseTraits::count * N; static constexpr int Dimension(int dim) { @@ -262,6 +281,7 @@ NAMESPACE_BEGIN(Grid); using Complexified = iMatrix; using Realified = iMatrix; using DoublePrecision = iMatrix; + using DoublePrecision2= iMatrix; static constexpr int Rank = BaseTraits::Rank + 2; static constexpr std::size_t count = BaseTraits::count * N * N; static constexpr int Dimension(int dim) { From 4701201b5ffd382fb15ebdf508204aba4a57b27d Mon Sep 17 00:00:00 2001 From: Michael Marshall <43034299+mmphys@users.noreply.github.com> Date: Wed, 22 Apr 2020 18:42:30 +0100 Subject: [PATCH 09/36] grid-config: Expose CXXLD (for GPU build) and update help --- grid-config.in | 6 ++++++ 1 file changed, 6 insertions(+) diff --git a/grid-config.in b/grid-config.in index f39b01bd..5de53aa7 100755 --- a/grid-config.in +++ b/grid-config.in @@ -19,6 +19,8 @@ Known values for OPTION are: --help display this help and exit --version output version information --git print git revision + --cxx print c++ compiler and compiler flags + --cxxld print c++ linker and linker flags EOF @@ -65,6 +67,10 @@ while test $# -gt 0; do echo @GRID_CXX@ ;; + --cxxld) + echo @CXXLD@ + ;; + --ldflags) echo @GRID_LDFLAGS@ ;; From ed70cce5428062c3097b94600b3503d25e529f0b Mon Sep 17 00:00:00 2001 From: Peter Boyle Date: Thu, 23 Apr 2020 04:29:45 -0400 Subject: [PATCH 10/36] Test for 5D DWF obserevables --- tests/debug/Test_cayley_mres.cc | 594 ++++++++++++++++++++++++++++++++ 1 file changed, 594 insertions(+) create mode 100644 tests/debug/Test_cayley_mres.cc diff --git a/tests/debug/Test_cayley_mres.cc b/tests/debug/Test_cayley_mres.cc new file mode 100644 index 00000000..0562546c --- /dev/null +++ b/tests/debug/Test_cayley_mres.cc @@ -0,0 +1,594 @@ +/************************************************************************************* + Grid physics library, www.github.com/paboyle/Grid + + Source file: ./tests/Test_cayley_cg.cc + + Copyright (C) 2015 + +Author: Peter Boyle +Author: paboyle + + This program is free software; you can redistribute it and/or modify + it under the terms of the GNU General Public License as published by + the Free Software Foundation; either version 2 of the License, or + (at your option) any later version. + + This program is distributed in the hope that it will be useful, + but WITHOUT ANY WARRANTY; without even the implied warranty of + MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the + GNU General Public License for more details. + + You should have received a copy of the GNU General Public License along + with this program; if not, write to the Free Software Foundation, Inc., + 51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. + + See the full license in the file "LICENSE" in the top level distribution directory + *************************************************************************************/ + /* END LEGAL */ +#include +#include + +using namespace std; +using namespace Grid; + + +template +void TestConserved(What & Ddwf, What & Ddwfrev, + LatticeGaugeField &Umu, + GridCartesian * FGrid, GridRedBlackCartesian * FrbGrid, + GridCartesian * UGrid, GridRedBlackCartesian * UrbGrid, + RealD mass, RealD M5, + GridParallelRNG *RNG4, + GridParallelRNG *RNG5); + + Gamma::Algebra Gmu [] = { + Gamma::Algebra::GammaX, + Gamma::Algebra::GammaY, + Gamma::Algebra::GammaZ, + Gamma::Algebra::GammaT, + Gamma::Algebra::Gamma5 + }; + +int main (int argc, char ** argv) +{ + Grid_init(&argc,&argv); + + int threads = GridThread::GetThreads(); + std::cout< omegas(10,ComplexD(1.0,0.0)); + std::vector < ComplexD > omegasrev(10,ComplexD(1.0,0.0)); + omegas.push_back( std::complex(0.0686324988446592,0.0550658530827402) ); + omegas.push_back( std::complex(0.0686324988446592,-0.0550658530827402) ); + omegas.push_back( std::complex(1.45806438985048,-0) ); + omegas.push_back( std::complex(0.830951166685955,-0) ); + omegas.push_back( std::complex(0.341985020453729,-0) ); + omegas.push_back( std::complex(0.126074299502912,-0) ); + omegas.push_back( std::complex(0.0990136651962626,-0) ); + omegas.push_back( std::complex(0.21137902619029,-0) ); + omegas.push_back( std::complex(0.542352409156791,-0) ); + omegas.push_back( std::complex(1.18231318389348,-0) ); + + GridCartesian * UGrid = SpaceTimeGrid::makeFourDimGrid(GridDefaultLatt(), + GridDefaultSimd(Nd,vComplex::Nsimd()), + GridDefaultMpi()); + GridRedBlackCartesian * UrbGrid = SpaceTimeGrid::makeFourDimRedBlackGrid(UGrid); + GridCartesian * FGrid = SpaceTimeGrid::makeFiveDimGrid(Ls,UGrid); + GridRedBlackCartesian * FrbGrid = SpaceTimeGrid::makeFiveDimRedBlackGrid(Ls,UGrid); + + + GridCartesian * UGridF = SpaceTimeGrid::makeFourDimGrid(GridDefaultLatt(), + GridDefaultSimd(Nd,vComplexF::Nsimd()), + GridDefaultMpi()); + GridRedBlackCartesian * UrbGridF = SpaceTimeGrid::makeFourDimRedBlackGrid(UGridF); + GridCartesian * FGridF = SpaceTimeGrid::makeFiveDimGrid(Ls,UGridF); + GridRedBlackCartesian * FrbGridF = SpaceTimeGrid::makeFiveDimRedBlackGrid(Ls,UGridF); + + + std::vector seeds4({1,2,3,4}); + std::vector seeds5({5,6,7,8}); + GridParallelRNG RNG5(FGrid); RNG5.SeedFixedIntegers(seeds5); + GridParallelRNG RNG4(UGrid); RNG4.SeedFixedIntegers(seeds4); + + LatticeGaugeField Umu(UGrid); + // SU3::ColdConfiguration(Umu); + SU3::HotConfiguration(RNG4,Umu); + + RealD mass=0.2; + RealD M5 =1.0; + std::cout<(Ddwf,Ddwf,Umu,FGrid,FrbGrid,UGrid,UrbGrid,mass,M5,&RNG4,&RNG5); + + RealD b=1.5;// Scale factor b+c=2, b-c=1 + RealD c=0.5; + std::vector gamma(Ls,ComplexD(1.0,0.0)); + + std::cout<(Dmob,Dmob,Umu,FGrid,FrbGrid,UGrid,UrbGrid,mass,M5,&RNG4,&RNG5); + + std::cout<(Dsham,Dsham,Umu,FGrid,FrbGrid,UGrid,UrbGrid,mass,M5,&RNG4,&RNG5); + + + std::cout<(ZDmob,ZDmobrev,Umu,FGrid,FrbGrid,UGrid,UrbGrid,mass,M5,&RNG4,&RNG5); + + Grid_finalize(); +} + + + +template +void TestConserved(Action & Ddwf, Action & Ddwfrev, + LatticeGaugeField &Umu, + GridCartesian * FGrid, GridRedBlackCartesian * FrbGrid, + GridCartesian * UGrid, GridRedBlackCartesian * UrbGrid, + RealD mass, RealD M5, + GridParallelRNG *RNG4, + GridParallelRNG *RNG5) +{ + int Ls=Ddwf.Ls; + + LatticePropagator phys_src(UGrid); + + std::vector U(4,UGrid); + + LatticePropagator seqsrc(FGrid); + LatticePropagator prop5(FGrid); + LatticePropagator prop5rev(FGrid); + LatticePropagator prop4(UGrid); + LatticePropagator Axial_mu(UGrid); + LatticeComplex PA (UGrid); + LatticeComplex PJ5q(UGrid); + LatticeComplex PP (UGrid); + LatticePropagator seqprop(UGrid); + + SpinColourMatrix kronecker; kronecker=1.0; + Coordinate coor({0,0,0,0}); + phys_src=Zero(); + pokeSite(kronecker,phys_src,coor); + + MdagMLinearOperator HermOp(Ddwf); + MdagMLinearOperator HermOprev(Ddwfrev); + ConjugateGradient CG(1.0e-12,10000); + for(int s=0;s(src4,phys_src,s,c); + + LatticeFermion src5 (FGrid); + Ddwf.ImportPhysicalFermionSource(src4,src5); + + LatticeFermion result5(FGrid); result5=Zero(); + + // CGNE + LatticeFermion Mdagsrc5 (FGrid); + Ddwf.Mdag(src5,Mdagsrc5); + CG(HermOp,Mdagsrc5,result5); + FermToProp(prop5,result5,s,c); + + LatticeFermion result4(UGrid); + Ddwf.ExportPhysicalFermionSolution(result5,result4); + FermToProp(prop4,result4,s,c); + + Ddwfrev.Mdag(src5,Mdagsrc5); + CG(HermOprev,Mdagsrc5,result5); + FermToProp(prop5rev,result5,s,c); + } + } + + +#if 1 + auto curr = Current::Axial; + const int mu_J=Nd-1; +#else + auto curr = Current::Vector; + const int mu_J=0; +#endif + const int t_J=0; + + LatticeComplex ph (UGrid); ph=1.0; + + Ddwfrev.SeqConservedCurrent(prop5rev, + seqsrc, + phys_src, + curr, + mu_J, + t_J, + t_J,// whole lattice + ph); + + for(int s=0;s(src5,seqsrc,s,c); + + LatticeFermion result5(FGrid); result5=Zero(); + + // CGNE + LatticeFermion Mdagsrc5 (FGrid); + Ddwf.Mdag(src5,Mdagsrc5); + CG(HermOp,Mdagsrc5,result5); + + LatticeFermion result4(UGrid); + Ddwf.ExportPhysicalFermionSolution(result5,result4); + FermToProp(seqprop,result4,s,c); + } + } + + Gamma g5(Gamma::Algebra::Gamma5); + + std::vector sumPA; + std::vector sumPP; + std::vector sumPJ5q; + + + Ddwf.ContractConservedCurrent(prop5rev,prop5,Axial_mu,phys_src,Current::Axial,Tdir); + //Ddwf.ContractConservedCurrent(prop5rev,prop5,Axial_mu,Current::Axial,Tdir); + Ddwf.ContractJ5q(prop5,PJ5q); + + PA = trace(g5*Axial_mu); + PP = trace(adj(prop4)*prop4); + + // Spatial sum + sliceSum(PA,sumPA,Tdir); + sliceSum(PP,sumPP,Tdir); + sliceSum(PJ5q,sumPJ5q,Tdir); + + int Nt=sumPA.size(); + for(int t=0;t check_buf; + + test_S = trace(qSite*g); + test_V = trace(qSite*g*Gamma::gmu[mu_J]); + + // Ddwf.ContractConservedCurrent(prop5rev,prop5,cur,phys_src,Current::Axial,mu_J); + Ddwf.ContractConservedCurrent(prop5rev,prop5,cur,phys_src,curr,mu_J); + + c = trace(cur*g); + sliceSum(c, check_buf, Tp); + check_S = TensorRemove(check_buf[t_J]); + + auto gmu=Gamma::gmu[mu_J]; + c = trace(cur*g*gmu); + sliceSum(c, check_buf, Tp); + check_V = TensorRemove(check_buf[t_J]); + + std::cout< sumPAref; + std::vector sumPA; + std::vector sumPP; + std::vector sumPJ5qref; + std::vector sumPJ5q; + std::vector sumDefect; + + // Spatial sum + sliceSum(PAmu[Tdir],sumPAref,Tdir); + sliceSum(PA,sumPA,Tdir); + sliceSum(PJ5q,sumPJ5q,Tdir); + sliceSum(PP,sumPP,Tdir); + sliceSum(Defect,sumDefect,Tdir); + + Ddwf.ContractJ5q(prop5,PJ5q); + sliceSum(PJ5q,sumPJ5qref,Tdir); + + int Nt=sumPA.size(); + for(int t=0;t U(4,FGrid); + { + auto Umu5d_v = Umu5d.View(); + auto Umu_v = Umu.View(); + for(int ss=0;ssoSites();ss++){ + for(int s=0;s(Umu5d,mu); + } + LatticeFermion ref(FGrid); + LatticeFermion tmp(FGrid); + ref = Zero(); + for(int mu=0;muoSites(),{ + uint64_t ss= sss*Ls; + typedef vSpinColourVector spinor; + spinor tmp1, tmp2; + for(int s=0;s Date: Thu, 23 Apr 2020 04:34:01 -0400 Subject: [PATCH 11/36] Conserved current rewrite done. Zmobius working --- Grid/qcd/QCD.h | 44 +-- Grid/qcd/action/fermion/CayleyFermion5D.h | 26 ++ Grid/qcd/action/fermion/FermionOperator.h | 8 +- Grid/qcd/action/fermion/GparityWilsonImpl.h | 14 +- .../action/fermion/ImprovedStaggeredFermion.h | 2 + .../fermion/ImprovedStaggeredFermion5D.h | 6 +- Grid/qcd/action/fermion/WilsonFermion.h | 6 +- Grid/qcd/action/fermion/WilsonFermion5D.h | 18 - Grid/qcd/action/fermion/WilsonImpl.h | 18 +- Grid/qcd/action/fermion/WilsonKernels.h | 35 -- .../CayleyFermion5DImplementation.h | 347 ++++++++++++++++++ ...ImprovedStaggeredFermion5DImplementation.h | 6 +- .../ImprovedStaggeredFermionImplementation.h | 2 + .../WilsonFermion5DImplementation.h | 213 +---------- .../WilsonFermionImplementation.h | 8 + .../WilsonKernelsImplementation.h | 126 ------- ...ermion5DInstantiationGparityWilsonImplD.cc | 45 +-- ...ermion5DInstantiationGparityWilsonImplD.cc | 39 +- ...AFermionInstantiationGparityWilsonImplD.cc | 45 +-- ...AFermionInstantiationGparityWilsonImplD.cc | 45 +-- ...ermion5DInstantiationGparityWilsonImplD.cc | 40 +- ...rFermionInstantiationGparityWilsonImplD.cc | 41 +-- ...ermion5DInstantiationGparityWilsonImplD.cc | 41 +-- ...nFermionInstantiationGparityWilsonImplD.cc | 41 +-- ...nKernelsInstantiationGparityWilsonImplD.cc | 75 +--- ...MFermionInstantiationGparityWilsonImplD.cc | 38 +- ...rmion5DInstantiationGparityWilsonImplDF.cc | 45 +-- ...rmion5DInstantiationGparityWilsonImplDF.cc | 39 +- ...FermionInstantiationGparityWilsonImplDF.cc | 45 +-- ...FermionInstantiationGparityWilsonImplDF.cc | 45 +-- ...rmion5DInstantiationGparityWilsonImplDF.cc | 40 +- ...FermionInstantiationGparityWilsonImplDF.cc | 41 +-- ...rmion5DInstantiationGparityWilsonImplDF.cc | 41 +-- ...FermionInstantiationGparityWilsonImplDF.cc | 41 +-- ...KernelsInstantiationGparityWilsonImplDF.cc | 75 +--- ...FermionInstantiationGparityWilsonImplDF.cc | 38 +- ...ermion5DInstantiationGparityWilsonImplF.cc | 45 +-- ...ermion5DInstantiationGparityWilsonImplF.cc | 39 +- ...AFermionInstantiationGparityWilsonImplF.cc | 45 +-- ...AFermionInstantiationGparityWilsonImplF.cc | 45 +-- ...ermion5DInstantiationGparityWilsonImplF.cc | 40 +- ...rFermionInstantiationGparityWilsonImplF.cc | 41 +-- ...ermion5DInstantiationGparityWilsonImplF.cc | 41 +-- ...nFermionInstantiationGparityWilsonImplF.cc | 41 +-- ...nKernelsInstantiationGparityWilsonImplF.cc | 75 +--- ...MFermionInstantiationGparityWilsonImplF.cc | 38 +- ...rmion5DInstantiationGparityWilsonImplFH.cc | 45 +-- ...rmion5DInstantiationGparityWilsonImplFH.cc | 39 +- ...FermionInstantiationGparityWilsonImplFH.cc | 45 +-- ...FermionInstantiationGparityWilsonImplFH.cc | 45 +-- ...rmion5DInstantiationGparityWilsonImplFH.cc | 40 +- ...FermionInstantiationGparityWilsonImplFH.cc | 41 +-- ...rmion5DInstantiationGparityWilsonImplFH.cc | 41 +-- ...FermionInstantiationGparityWilsonImplFH.cc | 41 +-- ...KernelsInstantiationGparityWilsonImplFH.cc | 75 +--- ...FermionInstantiationGparityWilsonImplFH.cc | 38 +- ...redFermion5DInstantiationStaggeredImplD.cc | 45 +-- ...geredFermionInstantiationStaggeredImplD.cc | 38 +- ...geredKernelsInstantiationStaggeredImplD.cc | 40 +- ...redFermion5DInstantiationStaggeredImplF.cc | 45 +-- ...geredFermionInstantiationStaggeredImplF.cc | 38 +- ...geredKernelsInstantiationStaggeredImplF.cc | 40 +- ...loverFermionInstantiationWilsonAdjImplD.cc | 41 +-- ...ilsonFermionInstantiationWilsonAdjImplD.cc | 41 +-- ...ilsonKernelsInstantiationWilsonAdjImplD.cc | 48 +-- ...sonTMFermionInstantiationWilsonAdjImplD.cc | 38 +- ...loverFermionInstantiationWilsonAdjImplF.cc | 41 +-- ...ilsonFermionInstantiationWilsonAdjImplF.cc | 41 +-- ...ilsonKernelsInstantiationWilsonAdjImplF.cc | 48 +-- ...sonTMFermionInstantiationWilsonAdjImplF.cc | 38 +- ...CayleyFermion5DInstantiationWilsonImplD.cc | 45 +-- ...actionFermion5DInstantiationWilsonImplD.cc | 39 +- ...WallEOFAFermionInstantiationWilsonImplD.cc | 45 +-- ...biusEOFAFermionInstantiationWilsonImplD.cc | 45 +-- ...actionFermion5DInstantiationWilsonImplD.cc | 40 +- ...onCloverFermionInstantiationWilsonImplD.cc | 41 +-- ...WilsonFermion5DInstantiationWilsonImplD.cc | 41 +-- .../WilsonFermionInstantiationWilsonImplD.cc | 41 +-- .../WilsonKernelsInstantiationWilsonImplD.cc | 48 +-- ...WilsonTMFermionInstantiationWilsonImplD.cc | 38 +- ...ayleyFermion5DInstantiationWilsonImplDF.cc | 45 +-- ...ctionFermion5DInstantiationWilsonImplDF.cc | 39 +- ...allEOFAFermionInstantiationWilsonImplDF.cc | 45 +-- ...iusEOFAFermionInstantiationWilsonImplDF.cc | 45 +-- ...ctionFermion5DInstantiationWilsonImplDF.cc | 40 +- ...nCloverFermionInstantiationWilsonImplDF.cc | 41 +-- ...ilsonFermion5DInstantiationWilsonImplDF.cc | 41 +-- .../WilsonFermionInstantiationWilsonImplDF.cc | 41 +-- .../WilsonKernelsInstantiationWilsonImplDF.cc | 48 +-- ...ilsonTMFermionInstantiationWilsonImplDF.cc | 38 +- ...CayleyFermion5DInstantiationWilsonImplF.cc | 45 +-- ...actionFermion5DInstantiationWilsonImplF.cc | 39 +- ...WallEOFAFermionInstantiationWilsonImplF.cc | 45 +-- ...biusEOFAFermionInstantiationWilsonImplF.cc | 45 +-- ...actionFermion5DInstantiationWilsonImplF.cc | 40 +- ...onCloverFermionInstantiationWilsonImplF.cc | 41 +-- ...WilsonFermion5DInstantiationWilsonImplF.cc | 41 +-- .../WilsonFermionInstantiationWilsonImplF.cc | 41 +-- .../WilsonKernelsInstantiationWilsonImplF.cc | 48 +-- ...WilsonTMFermionInstantiationWilsonImplF.cc | 38 +- ...ayleyFermion5DInstantiationWilsonImplFH.cc | 45 +-- ...ctionFermion5DInstantiationWilsonImplFH.cc | 39 +- ...allEOFAFermionInstantiationWilsonImplFH.cc | 45 +-- ...iusEOFAFermionInstantiationWilsonImplFH.cc | 45 +-- ...ctionFermion5DInstantiationWilsonImplFH.cc | 40 +- ...nCloverFermionInstantiationWilsonImplFH.cc | 41 +-- ...ilsonFermion5DInstantiationWilsonImplFH.cc | 41 +-- .../WilsonFermionInstantiationWilsonImplFH.cc | 41 +-- .../WilsonKernelsInstantiationWilsonImplFH.cc | 48 +-- ...ilsonTMFermionInstantiationWilsonImplFH.cc | 38 +- ...ilsonKernelsInstantiationGparity.cc.master | 25 -- ...tiationWilsonTwoIndexAntiSymmetricImplD.cc | 41 +-- ...tiationWilsonTwoIndexAntiSymmetricImplD.cc | 41 +-- ...tiationWilsonTwoIndexAntiSymmetricImplD.cc | 48 +-- ...tiationWilsonTwoIndexAntiSymmetricImplD.cc | 38 +- ...tiationWilsonTwoIndexAntiSymmetricImplF.cc | 41 +-- ...tiationWilsonTwoIndexAntiSymmetricImplF.cc | 41 +-- ...tiationWilsonTwoIndexAntiSymmetricImplF.cc | 48 +-- ...tiationWilsonTwoIndexAntiSymmetricImplF.cc | 38 +- ...stantiationWilsonTwoIndexSymmetricImplD.cc | 41 +-- ...stantiationWilsonTwoIndexSymmetricImplD.cc | 41 +-- ...stantiationWilsonTwoIndexSymmetricImplD.cc | 48 +-- ...stantiationWilsonTwoIndexSymmetricImplD.cc | 38 +- ...stantiationWilsonTwoIndexSymmetricImplF.cc | 41 +-- ...stantiationWilsonTwoIndexSymmetricImplF.cc | 41 +-- ...stantiationWilsonTwoIndexSymmetricImplF.cc | 48 +-- ...stantiationWilsonTwoIndexSymmetricImplF.cc | 38 +- ...ayleyFermion5DInstantiationZWilsonImplD.cc | 45 +-- ...ctionFermion5DInstantiationZWilsonImplD.cc | 39 +- ...allEOFAFermionInstantiationZWilsonImplD.cc | 45 +-- ...iusEOFAFermionInstantiationZWilsonImplD.cc | 45 +-- ...ctionFermion5DInstantiationZWilsonImplD.cc | 40 +- ...ilsonFermion5DInstantiationZWilsonImplD.cc | 41 +-- .../WilsonKernelsInstantiationZWilsonImplD.cc | 48 +-- ...yleyFermion5DInstantiationZWilsonImplDF.cc | 45 +-- ...tionFermion5DInstantiationZWilsonImplDF.cc | 39 +- ...llEOFAFermionInstantiationZWilsonImplDF.cc | 45 +-- ...usEOFAFermionInstantiationZWilsonImplDF.cc | 45 +-- ...tionFermion5DInstantiationZWilsonImplDF.cc | 40 +- ...lsonFermion5DInstantiationZWilsonImplDF.cc | 41 +-- ...WilsonKernelsInstantiationZWilsonImplDF.cc | 48 +-- ...ayleyFermion5DInstantiationZWilsonImplF.cc | 45 +-- ...ctionFermion5DInstantiationZWilsonImplF.cc | 39 +- ...allEOFAFermionInstantiationZWilsonImplF.cc | 45 +-- ...iusEOFAFermionInstantiationZWilsonImplF.cc | 45 +-- ...ctionFermion5DInstantiationZWilsonImplF.cc | 40 +- ...ilsonFermion5DInstantiationZWilsonImplF.cc | 41 +-- .../WilsonKernelsInstantiationZWilsonImplF.cc | 48 +-- ...yleyFermion5DInstantiationZWilsonImplFH.cc | 45 +-- ...tionFermion5DInstantiationZWilsonImplFH.cc | 39 +- ...llEOFAFermionInstantiationZWilsonImplFH.cc | 45 +-- ...usEOFAFermionInstantiationZWilsonImplFH.cc | 45 +-- ...tionFermion5DInstantiationZWilsonImplFH.cc | 40 +- ...lsonFermion5DInstantiationZWilsonImplFH.cc | 41 +-- ...WilsonKernelsInstantiationZWilsonImplFH.cc | 48 +-- Hadrons/Modules/MSource/SeqConserved.hpp | 5 +- 156 files changed, 596 insertions(+), 6271 deletions(-) mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/GparityWilsonImplD/CayleyFermion5DInstantiationGparityWilsonImplD.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/GparityWilsonImplD/ContinuedFractionFermion5DInstantiationGparityWilsonImplD.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/GparityWilsonImplD/DomainWallEOFAFermionInstantiationGparityWilsonImplD.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/GparityWilsonImplD/MobiusEOFAFermionInstantiationGparityWilsonImplD.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/GparityWilsonImplD/PartialFractionFermion5DInstantiationGparityWilsonImplD.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/GparityWilsonImplD/WilsonCloverFermionInstantiationGparityWilsonImplD.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/GparityWilsonImplD/WilsonFermion5DInstantiationGparityWilsonImplD.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/GparityWilsonImplD/WilsonFermionInstantiationGparityWilsonImplD.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/GparityWilsonImplD/WilsonKernelsInstantiationGparityWilsonImplD.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/GparityWilsonImplD/WilsonTMFermionInstantiationGparityWilsonImplD.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/GparityWilsonImplDF/CayleyFermion5DInstantiationGparityWilsonImplDF.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/GparityWilsonImplDF/ContinuedFractionFermion5DInstantiationGparityWilsonImplDF.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/GparityWilsonImplDF/DomainWallEOFAFermionInstantiationGparityWilsonImplDF.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/GparityWilsonImplDF/MobiusEOFAFermionInstantiationGparityWilsonImplDF.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/GparityWilsonImplDF/PartialFractionFermion5DInstantiationGparityWilsonImplDF.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/GparityWilsonImplDF/WilsonCloverFermionInstantiationGparityWilsonImplDF.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/GparityWilsonImplDF/WilsonFermion5DInstantiationGparityWilsonImplDF.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/GparityWilsonImplDF/WilsonFermionInstantiationGparityWilsonImplDF.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/GparityWilsonImplDF/WilsonKernelsInstantiationGparityWilsonImplDF.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/GparityWilsonImplDF/WilsonTMFermionInstantiationGparityWilsonImplDF.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/GparityWilsonImplF/CayleyFermion5DInstantiationGparityWilsonImplF.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/GparityWilsonImplF/ContinuedFractionFermion5DInstantiationGparityWilsonImplF.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/GparityWilsonImplF/DomainWallEOFAFermionInstantiationGparityWilsonImplF.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/GparityWilsonImplF/MobiusEOFAFermionInstantiationGparityWilsonImplF.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/GparityWilsonImplF/PartialFractionFermion5DInstantiationGparityWilsonImplF.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/GparityWilsonImplF/WilsonCloverFermionInstantiationGparityWilsonImplF.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/GparityWilsonImplF/WilsonFermion5DInstantiationGparityWilsonImplF.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/GparityWilsonImplF/WilsonFermionInstantiationGparityWilsonImplF.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/GparityWilsonImplF/WilsonKernelsInstantiationGparityWilsonImplF.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/GparityWilsonImplF/WilsonTMFermionInstantiationGparityWilsonImplF.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/GparityWilsonImplFH/CayleyFermion5DInstantiationGparityWilsonImplFH.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/GparityWilsonImplFH/ContinuedFractionFermion5DInstantiationGparityWilsonImplFH.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/GparityWilsonImplFH/DomainWallEOFAFermionInstantiationGparityWilsonImplFH.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/GparityWilsonImplFH/MobiusEOFAFermionInstantiationGparityWilsonImplFH.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/GparityWilsonImplFH/PartialFractionFermion5DInstantiationGparityWilsonImplFH.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/GparityWilsonImplFH/WilsonCloverFermionInstantiationGparityWilsonImplFH.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/GparityWilsonImplFH/WilsonFermion5DInstantiationGparityWilsonImplFH.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/GparityWilsonImplFH/WilsonFermionInstantiationGparityWilsonImplFH.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/GparityWilsonImplFH/WilsonKernelsInstantiationGparityWilsonImplFH.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/GparityWilsonImplFH/WilsonTMFermionInstantiationGparityWilsonImplFH.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/StaggeredImplD/ImprovedStaggeredFermion5DInstantiationStaggeredImplD.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/StaggeredImplD/ImprovedStaggeredFermionInstantiationStaggeredImplD.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/StaggeredImplD/StaggeredKernelsInstantiationStaggeredImplD.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/StaggeredImplF/ImprovedStaggeredFermion5DInstantiationStaggeredImplF.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/StaggeredImplF/ImprovedStaggeredFermionInstantiationStaggeredImplF.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/StaggeredImplF/StaggeredKernelsInstantiationStaggeredImplF.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/WilsonAdjImplD/WilsonCloverFermionInstantiationWilsonAdjImplD.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/WilsonAdjImplD/WilsonFermionInstantiationWilsonAdjImplD.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/WilsonAdjImplD/WilsonKernelsInstantiationWilsonAdjImplD.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/WilsonAdjImplD/WilsonTMFermionInstantiationWilsonAdjImplD.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/WilsonAdjImplF/WilsonCloverFermionInstantiationWilsonAdjImplF.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/WilsonAdjImplF/WilsonFermionInstantiationWilsonAdjImplF.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/WilsonAdjImplF/WilsonKernelsInstantiationWilsonAdjImplF.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/WilsonAdjImplF/WilsonTMFermionInstantiationWilsonAdjImplF.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/WilsonImplD/CayleyFermion5DInstantiationWilsonImplD.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/WilsonImplD/ContinuedFractionFermion5DInstantiationWilsonImplD.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/WilsonImplD/DomainWallEOFAFermionInstantiationWilsonImplD.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/WilsonImplD/MobiusEOFAFermionInstantiationWilsonImplD.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/WilsonImplD/PartialFractionFermion5DInstantiationWilsonImplD.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/WilsonImplD/WilsonCloverFermionInstantiationWilsonImplD.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/WilsonImplD/WilsonFermion5DInstantiationWilsonImplD.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/WilsonImplD/WilsonFermionInstantiationWilsonImplD.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/WilsonImplD/WilsonKernelsInstantiationWilsonImplD.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/WilsonImplD/WilsonTMFermionInstantiationWilsonImplD.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/WilsonImplDF/CayleyFermion5DInstantiationWilsonImplDF.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/WilsonImplDF/ContinuedFractionFermion5DInstantiationWilsonImplDF.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/WilsonImplDF/DomainWallEOFAFermionInstantiationWilsonImplDF.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/WilsonImplDF/MobiusEOFAFermionInstantiationWilsonImplDF.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/WilsonImplDF/PartialFractionFermion5DInstantiationWilsonImplDF.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/WilsonImplDF/WilsonCloverFermionInstantiationWilsonImplDF.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/WilsonImplDF/WilsonFermion5DInstantiationWilsonImplDF.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/WilsonImplDF/WilsonFermionInstantiationWilsonImplDF.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/WilsonImplDF/WilsonKernelsInstantiationWilsonImplDF.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/WilsonImplDF/WilsonTMFermionInstantiationWilsonImplDF.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/WilsonImplF/CayleyFermion5DInstantiationWilsonImplF.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/WilsonImplF/ContinuedFractionFermion5DInstantiationWilsonImplF.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/WilsonImplF/DomainWallEOFAFermionInstantiationWilsonImplF.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/WilsonImplF/MobiusEOFAFermionInstantiationWilsonImplF.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/WilsonImplF/PartialFractionFermion5DInstantiationWilsonImplF.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/WilsonImplF/WilsonCloverFermionInstantiationWilsonImplF.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/WilsonImplF/WilsonFermion5DInstantiationWilsonImplF.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/WilsonImplF/WilsonFermionInstantiationWilsonImplF.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/WilsonImplF/WilsonKernelsInstantiationWilsonImplF.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/WilsonImplF/WilsonTMFermionInstantiationWilsonImplF.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/WilsonImplFH/CayleyFermion5DInstantiationWilsonImplFH.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/WilsonImplFH/ContinuedFractionFermion5DInstantiationWilsonImplFH.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/WilsonImplFH/DomainWallEOFAFermionInstantiationWilsonImplFH.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/WilsonImplFH/MobiusEOFAFermionInstantiationWilsonImplFH.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/WilsonImplFH/PartialFractionFermion5DInstantiationWilsonImplFH.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/WilsonImplFH/WilsonCloverFermionInstantiationWilsonImplFH.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/WilsonImplFH/WilsonFermion5DInstantiationWilsonImplFH.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/WilsonImplFH/WilsonFermionInstantiationWilsonImplFH.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/WilsonImplFH/WilsonKernelsInstantiationWilsonImplFH.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/WilsonImplFH/WilsonTMFermionInstantiationWilsonImplFH.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/WilsonTwoIndexAntiSymmetricImplD/WilsonCloverFermionInstantiationWilsonTwoIndexAntiSymmetricImplD.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/WilsonTwoIndexAntiSymmetricImplD/WilsonFermionInstantiationWilsonTwoIndexAntiSymmetricImplD.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/WilsonTwoIndexAntiSymmetricImplD/WilsonKernelsInstantiationWilsonTwoIndexAntiSymmetricImplD.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/WilsonTwoIndexAntiSymmetricImplD/WilsonTMFermionInstantiationWilsonTwoIndexAntiSymmetricImplD.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/WilsonTwoIndexAntiSymmetricImplF/WilsonCloverFermionInstantiationWilsonTwoIndexAntiSymmetricImplF.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/WilsonTwoIndexAntiSymmetricImplF/WilsonFermionInstantiationWilsonTwoIndexAntiSymmetricImplF.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/WilsonTwoIndexAntiSymmetricImplF/WilsonKernelsInstantiationWilsonTwoIndexAntiSymmetricImplF.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/WilsonTwoIndexAntiSymmetricImplF/WilsonTMFermionInstantiationWilsonTwoIndexAntiSymmetricImplF.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/WilsonTwoIndexSymmetricImplD/WilsonCloverFermionInstantiationWilsonTwoIndexSymmetricImplD.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/WilsonTwoIndexSymmetricImplD/WilsonFermionInstantiationWilsonTwoIndexSymmetricImplD.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/WilsonTwoIndexSymmetricImplD/WilsonKernelsInstantiationWilsonTwoIndexSymmetricImplD.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/WilsonTwoIndexSymmetricImplD/WilsonTMFermionInstantiationWilsonTwoIndexSymmetricImplD.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/WilsonTwoIndexSymmetricImplF/WilsonCloverFermionInstantiationWilsonTwoIndexSymmetricImplF.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/WilsonTwoIndexSymmetricImplF/WilsonFermionInstantiationWilsonTwoIndexSymmetricImplF.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/WilsonTwoIndexSymmetricImplF/WilsonKernelsInstantiationWilsonTwoIndexSymmetricImplF.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/WilsonTwoIndexSymmetricImplF/WilsonTMFermionInstantiationWilsonTwoIndexSymmetricImplF.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/ZWilsonImplD/CayleyFermion5DInstantiationZWilsonImplD.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/ZWilsonImplD/ContinuedFractionFermion5DInstantiationZWilsonImplD.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/ZWilsonImplD/DomainWallEOFAFermionInstantiationZWilsonImplD.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/ZWilsonImplD/MobiusEOFAFermionInstantiationZWilsonImplD.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/ZWilsonImplD/PartialFractionFermion5DInstantiationZWilsonImplD.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/ZWilsonImplD/WilsonFermion5DInstantiationZWilsonImplD.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/ZWilsonImplD/WilsonKernelsInstantiationZWilsonImplD.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/ZWilsonImplDF/CayleyFermion5DInstantiationZWilsonImplDF.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/ZWilsonImplDF/ContinuedFractionFermion5DInstantiationZWilsonImplDF.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/ZWilsonImplDF/DomainWallEOFAFermionInstantiationZWilsonImplDF.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/ZWilsonImplDF/MobiusEOFAFermionInstantiationZWilsonImplDF.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/ZWilsonImplDF/PartialFractionFermion5DInstantiationZWilsonImplDF.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/ZWilsonImplDF/WilsonFermion5DInstantiationZWilsonImplDF.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/ZWilsonImplDF/WilsonKernelsInstantiationZWilsonImplDF.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/ZWilsonImplF/CayleyFermion5DInstantiationZWilsonImplF.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/ZWilsonImplF/ContinuedFractionFermion5DInstantiationZWilsonImplF.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/ZWilsonImplF/DomainWallEOFAFermionInstantiationZWilsonImplF.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/ZWilsonImplF/MobiusEOFAFermionInstantiationZWilsonImplF.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/ZWilsonImplF/PartialFractionFermion5DInstantiationZWilsonImplF.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/ZWilsonImplF/WilsonFermion5DInstantiationZWilsonImplF.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/ZWilsonImplF/WilsonKernelsInstantiationZWilsonImplF.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/ZWilsonImplFH/CayleyFermion5DInstantiationZWilsonImplFH.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/ZWilsonImplFH/ContinuedFractionFermion5DInstantiationZWilsonImplFH.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/ZWilsonImplFH/DomainWallEOFAFermionInstantiationZWilsonImplFH.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/ZWilsonImplFH/MobiusEOFAFermionInstantiationZWilsonImplFH.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/ZWilsonImplFH/PartialFractionFermion5DInstantiationZWilsonImplFH.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/ZWilsonImplFH/WilsonFermion5DInstantiationZWilsonImplFH.cc mode change 100644 => 120000 Grid/qcd/action/fermion/instantiation/ZWilsonImplFH/WilsonKernelsInstantiationZWilsonImplFH.cc diff --git a/Grid/qcd/QCD.h b/Grid/qcd/QCD.h index 2c8e60da..faacac63 100644 --- a/Grid/qcd/QCD.h +++ b/Grid/qcd/QCD.h @@ -133,23 +133,23 @@ typedef iSpinColourMatrix vSpinColourMatrix; typedef iSpinColourMatrix vSpinColourMatrixF; typedef iSpinColourMatrix vSpinColourMatrixD; - // SpinColourSpinColour matrix - typedef iSpinColourSpinColourMatrix SpinColourSpinColourMatrix; - typedef iSpinColourSpinColourMatrix SpinColourSpinColourMatrixF; - typedef iSpinColourSpinColourMatrix SpinColourSpinColourMatrixD; +// SpinColourSpinColour matrix +typedef iSpinColourSpinColourMatrix SpinColourSpinColourMatrix; +typedef iSpinColourSpinColourMatrix SpinColourSpinColourMatrixF; +typedef iSpinColourSpinColourMatrix SpinColourSpinColourMatrixD; - typedef iSpinColourSpinColourMatrix vSpinColourSpinColourMatrix; - typedef iSpinColourSpinColourMatrix vSpinColourSpinColourMatrixF; - typedef iSpinColourSpinColourMatrix vSpinColourSpinColourMatrixD; +typedef iSpinColourSpinColourMatrix vSpinColourSpinColourMatrix; +typedef iSpinColourSpinColourMatrix vSpinColourSpinColourMatrixF; +typedef iSpinColourSpinColourMatrix vSpinColourSpinColourMatrixD; - // SpinColourSpinColour matrix - typedef iSpinColourSpinColourMatrix SpinColourSpinColourMatrix; - typedef iSpinColourSpinColourMatrix SpinColourSpinColourMatrixF; - typedef iSpinColourSpinColourMatrix SpinColourSpinColourMatrixD; +// SpinColourSpinColour matrix +typedef iSpinColourSpinColourMatrix SpinColourSpinColourMatrix; +typedef iSpinColourSpinColourMatrix SpinColourSpinColourMatrixF; +typedef iSpinColourSpinColourMatrix SpinColourSpinColourMatrixD; - typedef iSpinColourSpinColourMatrix vSpinColourSpinColourMatrix; - typedef iSpinColourSpinColourMatrix vSpinColourSpinColourMatrixF; - typedef iSpinColourSpinColourMatrix vSpinColourSpinColourMatrixD; +typedef iSpinColourSpinColourMatrix vSpinColourSpinColourMatrix; +typedef iSpinColourSpinColourMatrix vSpinColourSpinColourMatrixF; +typedef iSpinColourSpinColourMatrix vSpinColourSpinColourMatrixD; // LorentzColour typedef iLorentzColourMatrix LorentzColourMatrix; @@ -443,16 +443,16 @@ template void pokeLorentz(vobj &lhs,const decltype(peekIndex propagator assignements ////////////////////////////////////////////// - //template - template - void FermToProp(typename Fimpl::PropagatorField &p, const typename Fimpl::FermionField &f, const int s, const int c) +//template +template +void FermToProp(typename Fimpl::PropagatorField &p, const typename Fimpl::FermionField &f, const int s, const int c) { for(int j = 0; j < Ns; ++j) { auto pjs = peekSpin(p, j, s); auto fj = peekSpin(f, j); - for(int i = 0; i < Fimpl::Dimension; ++i) + for(int i = 0; i < Fimpl::Dimension; ++i) { pokeColour(pjs, peekColour(fj, i), i, c); } @@ -460,16 +460,16 @@ template void pokeLorentz(vobj &lhs,const decltype(peekIndex - template - void PropToFerm(typename Fimpl::FermionField &f, const typename Fimpl::PropagatorField &p, const int s, const int c) +//template +template +void PropToFerm(typename Fimpl::FermionField &f, const typename Fimpl::PropagatorField &p, const int s, const int c) { for(int j = 0; j < Ns; ++j) { auto pjs = peekSpin(p, j, s); auto fj = peekSpin(f, j); - for(int i = 0; i < Fimpl::Dimension; ++i) + for(int i = 0; i < Fimpl::Dimension; ++i) { pokeColour(fj, peekColour(pjs, i, c), i); } diff --git a/Grid/qcd/action/fermion/CayleyFermion5D.h b/Grid/qcd/action/fermion/CayleyFermion5D.h index 333ba49b..8034b552 100644 --- a/Grid/qcd/action/fermion/CayleyFermion5D.h +++ b/Grid/qcd/action/fermion/CayleyFermion5D.h @@ -140,7 +140,33 @@ public: Vector > MatpInvDag; Vector > MatmInvDag; + /////////////////////////////////////////////////////////////// + // Conserved current utilities + /////////////////////////////////////////////////////////////// + + // Virtual can't template + void ContractConservedCurrent(PropagatorField &q_in_1, + PropagatorField &q_in_2, + PropagatorField &q_out, + PropagatorField &phys_src, + Current curr_type, + unsigned int mu); + + void SeqConservedCurrent(PropagatorField &q_in, + PropagatorField &q_out, + PropagatorField &phys_src, + Current curr_type, + unsigned int mu, + unsigned int tmin, + unsigned int tmax, + ComplexField &lattice_cmplx); + + void ContractJ5q(PropagatorField &q_in,ComplexField &J5q); + void ContractJ5q(FermionField &q_in,ComplexField &J5q); + + /////////////////////////////////////////////////////////////// // Constructors + /////////////////////////////////////////////////////////////// CayleyFermion5D(GaugeField &_Umu, GridCartesian &FiveDimGrid, GridRedBlackCartesian &FiveDimRedBlackGrid, diff --git a/Grid/qcd/action/fermion/FermionOperator.h b/Grid/qcd/action/fermion/FermionOperator.h index c60a2e84..3879dc3e 100644 --- a/Grid/qcd/action/fermion/FermionOperator.h +++ b/Grid/qcd/action/fermion/FermionOperator.h @@ -147,15 +147,19 @@ public: virtual void ContractConservedCurrent(PropagatorField &q_in_1, PropagatorField &q_in_2, PropagatorField &q_out, + PropagatorField &phys_src, Current curr_type, - unsigned int mu)=0; + unsigned int mu) + {assert(0);}; virtual void SeqConservedCurrent(PropagatorField &q_in, PropagatorField &q_out, + PropagatorField &phys_src, Current curr_type, unsigned int mu, unsigned int tmin, unsigned int tmax, - ComplexField &lattice_cmplx)=0; + ComplexField &lattice_cmplx) + {assert(0);}; // Only reimplemented in Wilson5D // Default to just a zero correlation function diff --git a/Grid/qcd/action/fermion/GparityWilsonImpl.h b/Grid/qcd/action/fermion/GparityWilsonImpl.h index f87d2260..0b147b3f 100644 --- a/Grid/qcd/action/fermion/GparityWilsonImpl.h +++ b/Grid/qcd/action/fermion/GparityWilsonImpl.h @@ -38,6 +38,7 @@ public: static const bool isFundamental = Representation::isFundamental; static const int Nhcs = Options::Nhcs; static const bool LsVectorised=false; + static const bool isGparity=true; typedef ConjugateGaugeImpl< GaugeImplTypes > Gimpl; INHERIT_GIMPL_TYPES(Gimpl); @@ -46,7 +47,7 @@ public: typedef typename Options::template PrecisionMapper::LowerPrecVector SimdL; template using iImplSpinor = iVector, Ns>, Ngp>; - template using iImplPropagator = iVector, Ns>, Ngp>; + template using iImplPropagator = iMatrix, Ns>, Ngp>; template using iImplHalfSpinor = iVector, Nhs>, Ngp>; template using iImplHalfCommSpinor = iVector, Nhcs>, Ngp>; template using iImplDoubledGaugeField = iVector >, Nds>, Ngp>; @@ -80,6 +81,7 @@ public: { assert(0); } + template static accelerator_inline void multLink(_Spinor &phi, const SiteDoubledGaugeField &U, @@ -191,6 +193,16 @@ public: #endif } + + template + inline void multLinkField(_SpinorField & out, + const DoubledGaugeField &Umu, + const _SpinorField & phi, + int mu) + { + assert(0); + } + template static accelerator_inline void loadLinkElement(Simd ®, ref &memory) { diff --git a/Grid/qcd/action/fermion/ImprovedStaggeredFermion.h b/Grid/qcd/action/fermion/ImprovedStaggeredFermion.h index b4d8d60b..5fe8246b 100644 --- a/Grid/qcd/action/fermion/ImprovedStaggeredFermion.h +++ b/Grid/qcd/action/fermion/ImprovedStaggeredFermion.h @@ -184,10 +184,12 @@ public: void ContractConservedCurrent(PropagatorField &q_in_1, PropagatorField &q_in_2, PropagatorField &q_out, + PropagatorField &src, Current curr_type, unsigned int mu); void SeqConservedCurrent(PropagatorField &q_in, PropagatorField &q_out, + PropagatorField &srct, Current curr_type, unsigned int mu, unsigned int tmin, diff --git a/Grid/qcd/action/fermion/ImprovedStaggeredFermion5D.h b/Grid/qcd/action/fermion/ImprovedStaggeredFermion5D.h index b10c0356..f7ab3a25 100644 --- a/Grid/qcd/action/fermion/ImprovedStaggeredFermion5D.h +++ b/Grid/qcd/action/fermion/ImprovedStaggeredFermion5D.h @@ -216,15 +216,17 @@ public: void ContractConservedCurrent(PropagatorField &q_in_1, PropagatorField &q_in_2, PropagatorField &q_out, + PropagatorField &src, Current curr_type, unsigned int mu); void SeqConservedCurrent(PropagatorField &q_in, PropagatorField &q_out, + PropagatorField &src, Current curr_type, unsigned int mu, unsigned int tmin, - unsigned int tmax, - ComplexField &lattice_cmplx); + unsigned int tmax, + ComplexField &lattice_cmplx); }; NAMESPACE_END(Grid); diff --git a/Grid/qcd/action/fermion/WilsonFermion.h b/Grid/qcd/action/fermion/WilsonFermion.h index 3a712435..b62fc0df 100644 --- a/Grid/qcd/action/fermion/WilsonFermion.h +++ b/Grid/qcd/action/fermion/WilsonFermion.h @@ -178,15 +178,17 @@ public: void ContractConservedCurrent(PropagatorField &q_in_1, PropagatorField &q_in_2, PropagatorField &q_out, + PropagatorField &phys_src, Current curr_type, unsigned int mu); void SeqConservedCurrent(PropagatorField &q_in, PropagatorField &q_out, + PropagatorField &phys_src, Current curr_type, unsigned int mu, unsigned int tmin, - unsigned int tmax, - ComplexField &lattice_cmplx); + unsigned int tmax, + ComplexField &lattice_cmplx); }; typedef WilsonFermion WilsonFermionF; diff --git a/Grid/qcd/action/fermion/WilsonFermion5D.h b/Grid/qcd/action/fermion/WilsonFermion5D.h index 8f1073db..aa2f51d4 100644 --- a/Grid/qcd/action/fermion/WilsonFermion5D.h +++ b/Grid/qcd/action/fermion/WilsonFermion5D.h @@ -213,25 +213,7 @@ public: // Comms buffer std::vector > comm_buf; - - /////////////////////////////////////////////////////////////// - // Conserved current utilities - /////////////////////////////////////////////////////////////// - void ContractConservedCurrent(PropagatorField &q_in_1, - PropagatorField &q_in_2, - PropagatorField &q_out, - Current curr_type, - unsigned int mu); - void SeqConservedCurrent(PropagatorField &q_in, - PropagatorField &q_out, - Current curr_type, - unsigned int mu, - unsigned int tmin, - unsigned int tmax, - ComplexField &lattice_cmplx); - void ContractJ5q(PropagatorField &q_in,ComplexField &J5q); - void ContractJ5q(FermionField &q_in,ComplexField &J5q); }; diff --git a/Grid/qcd/action/fermion/WilsonImpl.h b/Grid/qcd/action/fermion/WilsonImpl.h index 47160730..e78023cf 100644 --- a/Grid/qcd/action/fermion/WilsonImpl.h +++ b/Grid/qcd/action/fermion/WilsonImpl.h @@ -41,6 +41,7 @@ public: static const int Dimension = Representation::Dimension; static const bool isFundamental = Representation::isFundamental; static const bool LsVectorised=false; + static const bool isGparity=false; static const int Nhcs = Options::Nhcs; typedef PeriodicGaugeImpl > Gimpl; @@ -98,8 +99,21 @@ public: { multLink(phi,U,chi,mu); } - - + + template + inline void multLinkField(_SpinorField & out, + const DoubledGaugeField &Umu, + const _SpinorField & phi, + int mu) + { + auto out_v= out.View(); + auto phi_v= phi.View(); + auto Umu_v= Umu.View(); + thread_for(sss,out.Grid()->oSites(),{ + multLink(out_v[sss],Umu_v[sss],phi_v[sss],mu); + }); + } + template static accelerator_inline void loadLinkElement(Simd ®, ref &memory) { diff --git a/Grid/qcd/action/fermion/WilsonKernels.h b/Grid/qcd/action/fermion/WilsonKernels.h index 35715097..eaa49328 100644 --- a/Grid/qcd/action/fermion/WilsonKernels.h +++ b/Grid/qcd/action/fermion/WilsonKernels.h @@ -63,41 +63,6 @@ public: static void DhopDirKernel(StencilImpl &st, DoubledGaugeField &U,SiteHalfSpinor * buf, int Ls, int Nsite, const FermionField &in, FermionField &out, int dirdisp, int gamma); - ////////////////////////////////////////////////////////////////////////////// - // Utilities for inserting Wilson conserved current. - ////////////////////////////////////////////////////////////////////////////// - static void ContractConservedCurrentSiteFwd(const SitePropagator &q_in_1, - const SitePropagator &q_in_2, - SitePropagator &q_out, - DoubledGaugeFieldView &U, - unsigned int sU, - unsigned int mu, - bool switch_sign = false); - - static void ContractConservedCurrentSiteBwd(const SitePropagator &q_in_1, - const SitePropagator &q_in_2, - SitePropagator &q_out, - DoubledGaugeFieldView &U, - unsigned int sU, - unsigned int mu, - bool switch_sign = false); - - static void SeqConservedCurrentSiteFwd(const SitePropagator &q_in, - SitePropagator &q_out, - DoubledGaugeFieldView &U, - unsigned int sU, - unsigned int mu, - vPredicate t_mask, - bool switch_sign = false); - - static void SeqConservedCurrentSiteBwd(const SitePropagator &q_in, - SitePropagator &q_out, - DoubledGaugeFieldView &U, - unsigned int sU, - unsigned int mu, - vPredicate t_mask, - bool switch_sign = false); - private: static accelerator void DhopDirK(StencilView &st, DoubledGaugeFieldView &U,SiteHalfSpinor * buf, diff --git a/Grid/qcd/action/fermion/implementation/CayleyFermion5DImplementation.h b/Grid/qcd/action/fermion/implementation/CayleyFermion5DImplementation.h index 6823eb26..f9d0582d 100644 --- a/Grid/qcd/action/fermion/implementation/CayleyFermion5DImplementation.h +++ b/Grid/qcd/action/fermion/implementation/CayleyFermion5DImplementation.h @@ -580,6 +580,353 @@ void CayleyFermion5D::SetCoefficientsInternal(RealD zolo_hi,VectorMooeeInternalCompute(1,inv,MatpInvDag,MatmInvDag); } + +template +void CayleyFermion5D::ContractJ5q(FermionField &q_in,ComplexField &J5q) +{ + conformable(this->GaugeGrid(), J5q.Grid()); + conformable(q_in.Grid(), this->FermionGrid()); + Gamma G5(Gamma::Algebra::Gamma5); + // 4d field + int Ls = this->Ls; + FermionField psi(this->GaugeGrid()); + FermionField p_plus (this->GaugeGrid()); + FermionField p_minus(this->GaugeGrid()); + FermionField p(this->GaugeGrid()); + + ExtractSlice(p_plus , q_in, Ls/2-1 , 0); + ExtractSlice(p_minus, q_in, Ls/2 , 0); + p_plus = p_plus + G5*p_plus; + p_minus= p_minus - G5*p_minus; + p=0.5*(p_plus+p_minus); + J5q = localInnerProduct(p,p); +} + +template +void CayleyFermion5D::ContractJ5q(PropagatorField &q_in,ComplexField &J5q) +{ + conformable(this->GaugeGrid(), J5q.Grid()); + conformable(q_in.Grid(), this->FermionGrid()); + Gamma G5(Gamma::Algebra::Gamma5); + // 4d field + int Ls = this->Ls; + PropagatorField psi(this->GaugeGrid()); + PropagatorField p_plus (this->GaugeGrid()); + PropagatorField p_minus(this->GaugeGrid()); + PropagatorField p(this->GaugeGrid()); + + ExtractSlice(p_plus , q_in, Ls/2-1 , 0); + ExtractSlice(p_minus, q_in, Ls/2 , 0); + p_plus = p_plus + G5*p_plus; + p_minus= p_minus - G5*p_minus; + p=0.5*(p_plus+p_minus); + J5q = localInnerProduct(p,p); +} + +#define Pp(Q) (0.5*(Q+g5*Q)) +#define Pm(Q) (0.5*(Q-g5*Q)) +#define Q_4d(Q) (Pm((Q)[0]) + Pp((Q)[Ls-1])) +#define TopRowWithSource(Q) (phys_src + (1.0-mass)*Q_4d(Q)) + +template +void CayleyFermion5D::ContractConservedCurrent( PropagatorField &q_in_1, + PropagatorField &q_in_2, + PropagatorField &q_out, + PropagatorField &phys_src, + Current curr_type, + unsigned int mu) +{ + Gamma::Algebra Gmu [] = { + Gamma::Algebra::GammaX, + Gamma::Algebra::GammaY, + Gamma::Algebra::GammaZ, + Gamma::Algebra::GammaT, + Gamma::Algebra::Gamma5 + }; + + auto UGrid= this->GaugeGrid(); + auto FGrid= this->FermionGrid(); + RealD sgn=1.0; + if ( curr_type == Current::Axial ) sgn = -1.0; + + int Ls = this->Ls; + + std::vector L_Q(Ls,UGrid); + std::vector R_Q(Ls,UGrid); + for(int s=0;s R_TmLsGq(Ls,UGrid); + std::vector L_TmLsGq(Ls,UGrid); + for(int s=0;sbs[s]; + auto c=this->cs[s]; + auto bpc = 1.0/(b+c); // -0.5 factor in gauge links + if (s == 0) { + p5d =(b*Pm(L_TmLsGq[Ls-1])+ c*Pp(L_TmLsGq[Ls-1]) + b*Pp(L_TmLsTmp) + c*Pm(L_TmLsTmp )); + tmp =(b*Pm(R_TmLsGq0) + c*Pp(R_TmLsGq0 ) + b*Pp(R_TmLsGq[1]) + c*Pm(R_TmLsGq[1])); + } else if (s == Ls-1) { + p5d =(b*Pm(L_TmLsGq0) + c*Pp(L_TmLsGq0 ) + b*Pp(L_TmLsGq[1]) + c*Pm(L_TmLsGq[1])); + tmp =(b*Pm(R_TmLsGq[Ls-1])+ c*Pp(R_TmLsGq[Ls-1]) + b*Pp(R_TmLsTmp) + c*Pm(R_TmLsTmp )); + } else { + p5d =(b*Pm(L_TmLsGq[sr]) + c*Pp(L_TmLsGq[sr])+ b*Pp(L_TmLsGq[srp])+ c*Pm(L_TmLsGq[srp])); + tmp =(b*Pm(R_TmLsGq[s]) + c*Pp(R_TmLsGq[s]) + b*Pp(R_TmLsGq[sp ])+ c*Pm(R_TmLsGq[sp])); + } + tmp = Cshift(tmp,mu,1); + Impl::multLinkField(us_p5d,this->Umu,tmp,mu); + + gp5d=g5*p5d*g5; + gus_p5d=gmu*us_p5d; + + C = bpc*(adj(gp5d)*us_p5d); + C-= bpc*(adj(gp5d)*gus_p5d); + + if (s == 0) { + p5d =(b*Pm(R_TmLsGq0) + c*Pp(R_TmLsGq0 ) + b*Pp(R_TmLsGq[1]) + c*Pm(R_TmLsGq[1])); + tmp =(b*Pm(L_TmLsGq[Ls-1])+ c*Pp(L_TmLsGq[Ls-1]) + b*Pp(L_TmLsTmp) + c*Pm(L_TmLsTmp )); + } else if (s == Ls-1) { + p5d =(b*Pm(R_TmLsGq[Ls-1])+ c*Pp(R_TmLsGq[Ls-1]) + b*Pp(R_TmLsTmp) + c*Pm(R_TmLsTmp )); + tmp =(b*Pm(L_TmLsGq0) + c*Pp(L_TmLsGq0 ) + b*Pp(L_TmLsGq[1]) + c*Pm(L_TmLsGq[1])); + } else { + p5d =(b*Pm(R_TmLsGq[s]) + c*Pp(R_TmLsGq[s]) + b*Pp(R_TmLsGq[sp ])+ c*Pm(R_TmLsGq[sp])); + tmp =(b*Pm(L_TmLsGq[sr]) + c*Pp(L_TmLsGq[sr]) + b*Pp(L_TmLsGq[srp])+ c*Pm(L_TmLsGq[srp])); + } + tmp = Cshift(tmp,mu,1); + Impl::multLinkField(us_p5d,this->Umu,tmp,mu); + + gp5d=gmu*p5d; + gus_p5d=g5*us_p5d*g5; + + C-= bpc*(adj(gus_p5d)*gp5d); + C-= bpc*(adj(gus_p5d)*p5d); + + if (s < Ls/2) q_out += sgn*C; + else q_out += C; + + } +} + +template +void CayleyFermion5D::SeqConservedCurrent(PropagatorField &q_in, + PropagatorField &q_out, + PropagatorField &phys_src, + Current curr_type, + unsigned int mu, + unsigned int tmin, + unsigned int tmax, + ComplexField &ph)// Complex phase factor +{ + assert(mu>=0); + assert(muLs; + auto UGrid= this->GaugeGrid(); + auto FGrid= this->FermionGrid(); + Gamma::Algebra Gmu [] = { + Gamma::Algebra::GammaX, + Gamma::Algebra::GammaY, + Gamma::Algebra::GammaZ, + Gamma::Algebra::GammaT + }; + Gamma gmu=Gamma(Gmu[mu]); + + PropagatorField L_Q(UGrid); + PropagatorField R_Q(UGrid); + + PropagatorField tmp(UGrid); + PropagatorField Utmp(UGrid); + LatticeInteger zz (UGrid); zz=0.0; + LatticeInteger lcoor(UGrid); LatticeCoordinate(lcoor,Nd-1); + for (int s=0;sUmu,tmp,mu); + tmp = G_s*( Utmp*ph - gmu*Utmp*ph ); // Forward hop + tmp = where((lcoor>=tmin),tmp,zz); // Mask the time + tmp = where((lcoor<=tmax),tmp,zz); + L_Q = tmp; + + tmp = R_Q*ph; + tmp = Cshift(tmp,mu,-1); + Impl::multLinkField(Utmp,this->Umu,tmp,mu+Nd);// Adjoint link + tmp = -G_s*( Utmp + gmu*Utmp ); + tmp = where((lcoor>=tmin+tshift),tmp,zz); // Mask the time + tmp = where((lcoor<=tmax+tshift),tmp,zz); // Position of current complicated + L_Q= L_Q+tmp; + + InsertSlice(L_Q, q_out, s , 0); + } +#endif + +#if 1 + //////////////////////////////////////////////// + // GENERAL CAYLEY CASE + //////////////////////////////////////////////// + Gamma::Algebra Gmu [] = { + Gamma::Algebra::GammaX, + Gamma::Algebra::GammaY, + Gamma::Algebra::GammaZ, + Gamma::Algebra::GammaT, + Gamma::Algebra::Gamma5 + }; + Gamma gmu=Gamma(Gmu[mu]); + Gamma g5(Gamma::Algebra::Gamma5); + + int Ls = this->Ls; + auto UGrid= this->GaugeGrid(); + auto FGrid= this->FermionGrid(); + + std::vector R_Q(Ls,UGrid); + PropagatorField L_Q(UGrid); + PropagatorField tmp(UGrid); + PropagatorField Utmp(UGrid); + + LatticeInteger zz (UGrid); zz=0.0; + LatticeInteger lcoor(UGrid); LatticeCoordinate(lcoor,Nd-1); + + for(int s=0;s R_TmLsGq(Ls,UGrid); + for(int s=0;s G_s(Ls,1.0); + if ( curr_type == Current::Axial ) { + for(int s=0;sbs[s]; + auto c=this->cs[s]; + // auto bpc = G_s[s]*1.0/(b+c); // -0.5 factor in gauge links + + if (s == 0) { + tmp =(b*Pm(R_TmLsGq0) + c*Pp(R_TmLsGq0 ) + b*Pp(R_TmLsGq[1]) + c*Pm(R_TmLsGq[1])); + } else if (s == Ls-1) { + tmp =(b*Pm(R_TmLsGq[Ls-1])+ c*Pp(R_TmLsGq[Ls-1]) + b*Pp(R_TmLsTmp) + c*Pm(R_TmLsTmp )); + } else { + tmp =(b*Pm(R_TmLsGq[s]) + c*Pp(R_TmLsGq[s]) + b*Pp(R_TmLsGq[sp ])+ c*Pm(R_TmLsGq[sp])); + } + + tmp = Cshift(tmp,mu,1); + Impl::multLinkField(Utmp,this->Umu,tmp,mu); + tmp = G_s[s]*( Utmp*ph - gmu*Utmp*ph ); // Forward hop + tmp = where((lcoor>=tmin),tmp,zz); // Mask the time + L_Q = where((lcoor<=tmax),tmp,zz); // Position of current complicated + + if (s == 0) { + tmp =(b*Pm(R_TmLsGq0) + c*Pp(R_TmLsGq0 ) + b*Pp(R_TmLsGq[1]) + c*Pm(R_TmLsGq[1])); + } else if (s == Ls-1) { + tmp =(b*Pm(R_TmLsGq[Ls-1])+ c*Pp(R_TmLsGq[Ls-1]) + b*Pp(R_TmLsTmp) + c*Pm(R_TmLsTmp )); + } else { + tmp =(b*Pm(R_TmLsGq[s]) + c*Pp(R_TmLsGq[s]) + b*Pp(R_TmLsGq[sp])+ c*Pm(R_TmLsGq[sp])); + } + tmp = tmp *ph; + tmp = Cshift(tmp,mu,-1); + Impl::multLinkField(Utmp,this->Umu,tmp,mu+Nd); // Adjoint link + tmp = -G_s[s]*( Utmp + gmu*Utmp ); + tmp = where((lcoor>=tmin+tshift),tmp,zz); // Mask the time + L_Q += where((lcoor<=tmax+tshift),tmp,zz); // Position of current complicated + + InsertSlice(L_Q, q_out, s , 0); + } +#endif +} +#undef Pp +#undef Pm +#undef Q_4d +#undef TopRowWithSource + + + #if 0 template void CayleyFermion5D::MooeeInternalCompute(int dag, int inv, diff --git a/Grid/qcd/action/fermion/implementation/ImprovedStaggeredFermion5DImplementation.h b/Grid/qcd/action/fermion/implementation/ImprovedStaggeredFermion5DImplementation.h index c42e896f..8675600f 100644 --- a/Grid/qcd/action/fermion/implementation/ImprovedStaggeredFermion5DImplementation.h +++ b/Grid/qcd/action/fermion/implementation/ImprovedStaggeredFermion5DImplementation.h @@ -605,6 +605,7 @@ template void ImprovedStaggeredFermion5D::ContractConservedCurrent(PropagatorField &q_in_1, PropagatorField &q_in_2, PropagatorField &q_out, + PropagatorField &src, Current curr_type, unsigned int mu) { @@ -614,11 +615,12 @@ void ImprovedStaggeredFermion5D::ContractConservedCurrent(PropagatorField template void ImprovedStaggeredFermion5D::SeqConservedCurrent(PropagatorField &q_in, PropagatorField &q_out, + PropagatorField &src, Current curr_type, unsigned int mu, unsigned int tmin, - unsigned int tmax, - ComplexField &lattice_cmplx) + unsigned int tmax, + ComplexField &lattice_cmplx) { assert(0); diff --git a/Grid/qcd/action/fermion/implementation/ImprovedStaggeredFermionImplementation.h b/Grid/qcd/action/fermion/implementation/ImprovedStaggeredFermionImplementation.h index e2605d81..ac2283ce 100644 --- a/Grid/qcd/action/fermion/implementation/ImprovedStaggeredFermionImplementation.h +++ b/Grid/qcd/action/fermion/implementation/ImprovedStaggeredFermionImplementation.h @@ -593,6 +593,7 @@ template void ImprovedStaggeredFermion::ContractConservedCurrent(PropagatorField &q_in_1, PropagatorField &q_in_2, PropagatorField &q_out, + PropagatorField &src, Current curr_type, unsigned int mu) { @@ -602,6 +603,7 @@ void ImprovedStaggeredFermion::ContractConservedCurrent(PropagatorField &q template void ImprovedStaggeredFermion::SeqConservedCurrent(PropagatorField &q_in, PropagatorField &q_out, + PropagatorField &src, Current curr_type, unsigned int mu, unsigned int tmin, diff --git a/Grid/qcd/action/fermion/implementation/WilsonFermion5DImplementation.h b/Grid/qcd/action/fermion/implementation/WilsonFermion5DImplementation.h index 1bdc9a64..68d20741 100644 --- a/Grid/qcd/action/fermion/implementation/WilsonFermion5DImplementation.h +++ b/Grid/qcd/action/fermion/implementation/WilsonFermion5DImplementation.h @@ -852,7 +852,6 @@ void WilsonFermion5D::MomentumSpacePropagatorHw(FermionField &out,const Fe * Conserved current utilities for Wilson fermions, for contracting propagators * to make a conserved current sink or inserting the conserved current * sequentially. - ******************************************************************************/ // Helper macro to reverse Simd vector. Fixme: slow, generic implementation. #define REVERSE_LS(qSite, qSiteRev, Nsimd) \ @@ -868,220 +867,10 @@ void WilsonFermion5D::MomentumSpacePropagatorHw(FermionField &out,const Fe merge(qSiteRev, qSiteVec); \ } -// psi = chiralProjectPlus(Result_s[Ls/2-1]); -// psi+= chiralProjectMinus(Result_s[Ls/2]); -// PJ5q+=localInnerProduct(psi,psi); - -template -Lattice spProj5p(const Lattice & in) -{ - GridBase *grid=in.Grid(); - Gamma G5(Gamma::Algebra::Gamma5); - Lattice ret(grid); - auto ret_v = ret.View(); - auto in_v = in.View(); - thread_for(ss,grid->oSites(),{ - ret_v[ss] = in_v[ss] + G5*in_v[ss]; - }); - return ret; -} -template -Lattice spProj5m(const Lattice & in) -{ - Gamma G5(Gamma::Algebra::Gamma5); - GridBase *grid=in.Grid(); - Lattice ret(grid); - auto ret_v = ret.View(); - auto in_v = in.View(); - thread_for(ss,grid->oSites(),{ - ret_v[ss] = in_v[ss] - G5*in_v[ss]; - }); - return ret; -} - -template -void WilsonFermion5D::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 -void WilsonFermion5D::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 -void WilsonFermion5D::ContractConservedCurrent(PropagatorField &q_in_1, - PropagatorField &q_in_2, - PropagatorField &q_out, - Current curr_type, - unsigned int mu) -{ - conformable(q_in_1.Grid(), FermionGrid()); - conformable(q_in_1.Grid(), q_in_2.Grid()); - conformable(_FourDimGrid, q_out.Grid()); - - PropagatorField tmp1(FermionGrid()), tmp2(FermionGrid()); - unsigned int LLs = q_in_1.Grid()->_rdimensions[0]; - q_out = Zero(); - - // Forward, need q1(x + mu, s), q2(x, Ls - 1 - s). Backward, need q1(x, s), - // q2(x + mu, Ls - 1 - s). 5D lattice so shift 4D coordinate mu by one. - tmp1 = Cshift(q_in_1, mu + 1, 1); - tmp2 = Cshift(q_in_2, mu + 1, 1); - auto q_in_1_v = q_in_1.View(); - auto q_in_2_v = q_in_2.View(); - auto tmp1_v = tmp1.View(); - auto tmp2_v = tmp2.View(); - auto q_out_v = q_out.View(); - auto Umu_v = Umu.View(); - thread_for(sU, Umu.Grid()->oSites(),{ - - unsigned int sF1 = sU * LLs; - unsigned int sF2 = (sU + 1) * LLs - 1; - - for (unsigned int s = 0; s < LLs; ++s) - { - bool axial_sign = ((curr_type == Current::Axial) && \ - (s < (LLs / 2))); - SitePropagator qSite2, qmuSite2; - - // If vectorised in 5th dimension, reverse q2 vector to match up - // sites correctly. - if (Impl::LsVectorised) - { - REVERSE_LS(q_in_2_v[sF2], qSite2, Ls / LLs); - REVERSE_LS(tmp2_v[sF2], qmuSite2, Ls / LLs); - } - else - { - qSite2 = q_in_2_v[sF2]; - qmuSite2 = tmp2_v[sF2]; - } - Kernels::ContractConservedCurrentSiteFwd(tmp1_v[sF1], - qSite2, - q_out_v[sU], - Umu_v, sU, mu, axial_sign); - Kernels::ContractConservedCurrentSiteBwd(q_in_1_v[sF1], - qmuSite2, - q_out_v[sU], - Umu_v, sU, mu, axial_sign); - sF1++; - sF2--; - } - }); -} + ******************************************************************************/ -template -void WilsonFermion5D::SeqConservedCurrent(PropagatorField &q_in, - PropagatorField &q_out, - Current curr_type, - unsigned int mu, - unsigned int tmin, - unsigned int tmax, - ComplexField &lattice_cmplx) -{ - conformable(q_in.Grid(), FermionGrid()); - conformable(q_in.Grid(), q_out.Grid()); - PropagatorField tmp(GaugeGrid()),tmp2(GaugeGrid()); - unsigned int tshift = (mu == Tp) ? 1 : 0; - unsigned int LLs = q_in.Grid()->_rdimensions[0]; - unsigned int LLt = GridDefaultLatt()[Tp]; - q_out = Zero(); - LatticeInteger coords(_FourDimGrid); - LatticeCoordinate(coords, Tp); - - auto q_out_v = q_out.View(); - auto tmp2_v = tmp2.View(); - auto coords_v= coords.View(); - auto Umu_v = Umu.View(); - for (unsigned int s = 0; s < LLs; ++s) - { - bool axial_sign = ((curr_type == Current::Axial) && (s < (LLs / 2))); - bool tadpole_sign = (curr_type == Current::Tadpole); - bool switch_sgn = tadpole_sign || axial_sign; - - - //forward direction: Need q(x + mu, s)*A(x) - ExtractSlice(tmp2, q_in, s, 0); //q(x,s) - tmp = Cshift(tmp2, mu, 1); //q(x+mu,s) - tmp2 = tmp*lattice_cmplx; //q(x+mu,s)*A(x) - - thread_for(sU, Umu.Grid()->oSites(),{ - // Compute the sequential conserved current insertion only if our simd - // object contains a timeslice we need. - vPredicate t_mask; - t_mask() = ((coords_v[sU] >= tmin) && (coords_v[sU] <= tmax)); - Integer timeSlices = Reduce(t_mask()); - - if (timeSlices > 0) - { - unsigned int sF = sU * LLs + s; - Kernels::SeqConservedCurrentSiteFwd(tmp2_v[sU], - q_out_v[sF], Umu_v, sU, - mu, t_mask, switch_sgn); - } - - }); - - //backward direction: Need q(x - mu, s)*A(x-mu) - ExtractSlice(tmp2, q_in, s, 0); //q(x,s) - tmp = lattice_cmplx*tmp2; //q(x,s)*A(x) - tmp2 = Cshift(tmp, mu, -1); //q(x-mu,s)*A(x-mu,s) - - thread_for(sU, Umu.Grid()->oSites(), - { - vPredicate t_mask; - t_mask()= ((coords_v[sU] >= (tmin + tshift)) && (coords_v[sU] <= (tmax + tshift))); - - //if tmax = LLt-1 (last timeslice) include timeslice 0 if the time is shifted (mu=3) - unsigned int t0 = 0; - if((tmax==LLt-1) && (tshift==1)) t_mask() = (t_mask() || (coords_v[sU] == t0 )); - - Integer timeSlices = Reduce(t_mask()); - - if (timeSlices > 0) { - unsigned int sF = sU * LLs + s; - Kernels::SeqConservedCurrentSiteBwd(tmp2_v[sU], - q_out_v[sF], Umu_v, sU, - mu, t_mask, axial_sign); - } - }); - } -} NAMESPACE_END(Grid); diff --git a/Grid/qcd/action/fermion/implementation/WilsonFermionImplementation.h b/Grid/qcd/action/fermion/implementation/WilsonFermionImplementation.h index 756bdbf4..686b67ca 100644 --- a/Grid/qcd/action/fermion/implementation/WilsonFermionImplementation.h +++ b/Grid/qcd/action/fermion/implementation/WilsonFermionImplementation.h @@ -435,6 +435,7 @@ template void WilsonFermion::ContractConservedCurrent(PropagatorField &q_in_1, PropagatorField &q_in_2, PropagatorField &q_out, + PropagatorField &src, Current curr_type, unsigned int mu) { @@ -442,6 +443,7 @@ void WilsonFermion::ContractConservedCurrent(PropagatorField &q_in_1, conformable(_grid, q_in_1.Grid()); conformable(_grid, q_in_2.Grid()); conformable(_grid, q_out.Grid()); +#if 0 PropagatorField tmp1(_grid), tmp2(_grid); q_out = Zero(); @@ -465,12 +467,15 @@ void WilsonFermion::ContractConservedCurrent(PropagatorField &q_in_1, q_out_v[sU], Umu_v, sU, mu); }); +#else +#endif } template void WilsonFermion::SeqConservedCurrent(PropagatorField &q_in, PropagatorField &q_out, + PropagatorField &src, Current curr_type, unsigned int mu, unsigned int tmin, @@ -479,6 +484,7 @@ void WilsonFermion::SeqConservedCurrent(PropagatorField &q_in, { conformable(_grid, q_in.Grid()); conformable(_grid, q_out.Grid()); +#if 0 // Lattice> ph(_grid), coor(_grid); Complex i(0.0,1.0); @@ -532,6 +538,8 @@ void WilsonFermion::SeqConservedCurrent(PropagatorField &q_in, Umu_v, sU, mu, t_mask); } }); +#else +#endif } NAMESPACE_END(Grid); diff --git a/Grid/qcd/action/fermion/implementation/WilsonKernelsImplementation.h b/Grid/qcd/action/fermion/implementation/WilsonKernelsImplementation.h index a787fa79..7397ed92 100644 --- a/Grid/qcd/action/fermion/implementation/WilsonKernelsImplementation.h +++ b/Grid/qcd/action/fermion/implementation/WilsonKernelsImplementation.h @@ -421,131 +421,5 @@ void WilsonKernels::DhopKernel(int Opt,StencilImpl &st, DoubledGaugeField assert(0 && " Kernel optimisation case not covered "); } -/******************************************************************************* - * Conserved current utilities for Wilson fermions, for contracting propagators - * to make a conserved current sink or inserting the conserved current - * sequentially. Common to both 4D and 5D. - ******************************************************************************/ -// N.B. Functions below assume a -1/2 factor within U. -#define WilsonCurrentFwd(expr, mu) ((expr - Gamma::gmu[mu]*expr)) -#define WilsonCurrentBwd(expr, mu) ((expr + Gamma::gmu[mu]*expr)) - -/******************************************************************************* - * Name: ContractConservedCurrentSiteFwd - * Operation: (1/2) * q2[x] * U(x) * (g[mu] - 1) * q1[x + mu] - * Notes: - DoubledGaugeField U assumed to contain -1/2 factor. - * - Pass in q_in_1 shifted in +ve mu direction. - ******************************************************************************/ -template -void WilsonKernels::ContractConservedCurrentSiteFwd(const SitePropagator &q_in_1, - const SitePropagator &q_in_2, - SitePropagator &q_out, - DoubledGaugeFieldView &U, - unsigned int sU, - unsigned int mu, - bool switch_sign) -{ - SitePropagator result, tmp; - Gamma g5(Gamma::Algebra::Gamma5); - - Impl::multLink(tmp, U[sU], q_in_1, mu); - - result = g5 * adj(q_in_2) * g5 * WilsonCurrentFwd(tmp, mu); - - if (switch_sign) { - q_out -= result; - } else { - q_out += result; - } -} - -/******************************************************************************* - * Name: ContractConservedCurrentSiteBwd - * Operation: (1/2) * q2[x + mu] * U^dag(x) * (g[mu] + 1) * q1[x] - * Notes: - DoubledGaugeField U assumed to contain -1/2 factor. - * - Pass in q_in_2 shifted in +ve mu direction. - ******************************************************************************/ -template -void WilsonKernels::ContractConservedCurrentSiteBwd(const SitePropagator &q_in_1, - const SitePropagator &q_in_2, - SitePropagator &q_out, - DoubledGaugeFieldView &U, - unsigned int sU, - unsigned int mu, - bool switch_sign) -{ - SitePropagator result, tmp; - Gamma g5(Gamma::Algebra::Gamma5); - - Impl::multLink(tmp, U[sU], q_in_1, mu + Nd); - - result = g5 * adj(q_in_2) * g5 * WilsonCurrentBwd(tmp, mu); - if (switch_sign) { - q_out += result; - } else { - q_out -= result; - } -} - -/******************************************************************************* - * Name: SeqConservedCurrentSiteFwd - * Operation: (1/2) * U(x) * (g[mu] - 1) * q[x + mu] - * Notes: - DoubledGaugeField U assumed to contain -1/2 factor. - * - Pass in q_in shifted in +ve mu direction. - ******************************************************************************/ -template -void WilsonKernels::SeqConservedCurrentSiteFwd(const SitePropagator &q_in, - SitePropagator &q_out, - DoubledGaugeFieldView &U, - unsigned int sU, - unsigned int mu, - vPredicate t_mask, - bool switch_sign) -{ - SitePropagator result; - - Impl::multLink(result, U[sU], q_in, mu); - result = WilsonCurrentFwd(result, mu); - - // Zero any unwanted timeslice entries. - result = predicatedWhere(t_mask, result, 0.*result); - - if (switch_sign) { - q_out -= result; - } else { - q_out += result; - } -} - -/******************************************************************************* - * Name: SeqConservedCurrentSiteFwd - * Operation: (1/2) * U^dag(x) * (g[mu] + 1) * q[x - mu] - * Notes: - DoubledGaugeField U assumed to contain -1/2 factor. - * - Pass in q_in shifted in -ve mu direction. - ******************************************************************************/ -template -void WilsonKernels::SeqConservedCurrentSiteBwd(const SitePropagator &q_in, - SitePropagator &q_out, - DoubledGaugeFieldView &U, - unsigned int sU, - unsigned int mu, - vPredicate t_mask, - bool switch_sign) -{ - SitePropagator result; - Impl::multLink(result, U[sU], q_in, mu + Nd); - result = WilsonCurrentBwd(result, mu); - - // Zero any unwanted timeslice entries. - result = predicatedWhere(t_mask, result, 0.*result); - - if (switch_sign) { - q_out += result; - } else { - q_out -= result; - } -} - - NAMESPACE_END(Grid); diff --git a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplD/CayleyFermion5DInstantiationGparityWilsonImplD.cc b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplD/CayleyFermion5DInstantiationGparityWilsonImplD.cc deleted file mode 100644 index 5130db9c..00000000 --- a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplD/CayleyFermion5DInstantiationGparityWilsonImplD.cc +++ /dev/null @@ -1,44 +0,0 @@ -/************************************************************************************* - -Grid physics library, www.github.com/paboyle/Grid - -Source file: ./lib/qcd/action/fermion/WilsonKernels.cc - -Copyright (C) 2015 - -Author: Peter Boyle -Author: Peter Boyle -Author: paboyle - -This program is free software; you can redistribute it and/or modify -it under the terms of the GNU General Public License as published by -the Free Software Foundation; either version 2 of the License, or -(at your option) any later version. - -This program is distributed in the hope that it will be useful, -but WITHOUT ANY WARRANTY; without even the implied warranty of -MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the -GNU General Public License for more details. - -You should have received a copy of the GNU General Public License along -with this program; if not, write to the Free Software Foundation, Inc., -51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. - -See the full license in the file "LICENSE" in the top level distribution -directory -*************************************************************************************/ -/* END LEGAL */ -#include -#include -#include - - //#include - //#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class CayleyFermion5D; - -NAMESPACE_END(Grid); - diff --git a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplD/CayleyFermion5DInstantiationGparityWilsonImplD.cc b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplD/CayleyFermion5DInstantiationGparityWilsonImplD.cc new file mode 120000 index 00000000..cb1db625 --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplD/CayleyFermion5DInstantiationGparityWilsonImplD.cc @@ -0,0 +1 @@ +../CayleyFermion5DInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplD/ContinuedFractionFermion5DInstantiationGparityWilsonImplD.cc b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplD/ContinuedFractionFermion5DInstantiationGparityWilsonImplD.cc deleted file mode 100644 index ca0d6cea..00000000 --- a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplD/ContinuedFractionFermion5DInstantiationGparityWilsonImplD.cc +++ /dev/null @@ -1,38 +0,0 @@ -/************************************************************************************* - - Grid physics library, www.github.com/paboyle/Grid - - Source file: ./lib/qcd/action/fermion/ContinuedFractionFermion5D.cc - - Copyright (C) 2015 - -Author: Peter Boyle -Author: Peter Boyle - - This program is free software; you can redistribute it and/or modify - it under the terms of the GNU General Public License as published by - the Free Software Foundation; either version 2 of the License, or - (at your option) any later version. - - This program is distributed in the hope that it will be useful, - but WITHOUT ANY WARRANTY; without even the implied warranty of - MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the - GNU General Public License for more details. - - You should have received a copy of the GNU General Public License along - with this program; if not, write to the Free Software Foundation, Inc., - 51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. - - See the full license in the file "LICENSE" in the top level distribution directory -*************************************************************************************/ -/* END LEGAL */ -#include -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class ContinuedFractionFermion5D; - -NAMESPACE_END(Grid); diff --git a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplD/ContinuedFractionFermion5DInstantiationGparityWilsonImplD.cc b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplD/ContinuedFractionFermion5DInstantiationGparityWilsonImplD.cc new file mode 120000 index 00000000..c2d4b8fc --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplD/ContinuedFractionFermion5DInstantiationGparityWilsonImplD.cc @@ -0,0 +1 @@ +../ContinuedFractionFermion5DInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplD/DomainWallEOFAFermionInstantiationGparityWilsonImplD.cc b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplD/DomainWallEOFAFermionInstantiationGparityWilsonImplD.cc deleted file mode 100644 index f7198131..00000000 --- a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplD/DomainWallEOFAFermionInstantiationGparityWilsonImplD.cc +++ /dev/null @@ -1,44 +0,0 @@ -/************************************************************************************* - -Grid physics library, www.github.com/paboyle/Grid - -Source file: ./lib/qcd/action/fermion/DomainWallEOFAFermion.cc - -Copyright (C) 2017 - -Author: Peter Boyle -Author: Peter Boyle -Author: Peter Boyle -Author: paboyle -Author: David Murphy - -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 -#include -#include -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class DomainWallEOFAFermion; - -NAMESPACE_END(Grid); diff --git a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplD/DomainWallEOFAFermionInstantiationGparityWilsonImplD.cc b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplD/DomainWallEOFAFermionInstantiationGparityWilsonImplD.cc new file mode 120000 index 00000000..2f550a2b --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplD/DomainWallEOFAFermionInstantiationGparityWilsonImplD.cc @@ -0,0 +1 @@ +../DomainWallEOFAFermionInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplD/MobiusEOFAFermionInstantiationGparityWilsonImplD.cc b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplD/MobiusEOFAFermionInstantiationGparityWilsonImplD.cc deleted file mode 100644 index ce7eaac9..00000000 --- a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplD/MobiusEOFAFermionInstantiationGparityWilsonImplD.cc +++ /dev/null @@ -1,44 +0,0 @@ -/************************************************************************************* - -Grid physics library, www.github.com/paboyle/Grid - -Source file: ./lib/qcd/action/fermion/MobiusEOFAFermion.cc - -Copyright (C) 2017 - -Author: Peter Boyle -Author: Peter Boyle -Author: Peter Boyle -Author: paboyle -Author: David Murphy - -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 -#include -#include -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class MobiusEOFAFermion; - -NAMESPACE_END(Grid); diff --git a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplD/MobiusEOFAFermionInstantiationGparityWilsonImplD.cc b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplD/MobiusEOFAFermionInstantiationGparityWilsonImplD.cc new file mode 120000 index 00000000..7a8f1172 --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplD/MobiusEOFAFermionInstantiationGparityWilsonImplD.cc @@ -0,0 +1 @@ +../MobiusEOFAFermionInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplD/PartialFractionFermion5DInstantiationGparityWilsonImplD.cc b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplD/PartialFractionFermion5DInstantiationGparityWilsonImplD.cc deleted file mode 100644 index 757719b6..00000000 --- a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplD/PartialFractionFermion5DInstantiationGparityWilsonImplD.cc +++ /dev/null @@ -1,39 +0,0 @@ -/************************************************************************************* - - Grid physics library, www.github.com/paboyle/Grid - - Source file: ./lib/qcd/action/fermion/PartialFractionFermion5D.cc - - Copyright (C) 2015 - -Author: Peter Boyle -Author: Peter Boyle - - This program is free software; you can redistribute it and/or modify - it under the terms of the GNU General Public License as published by - the Free Software Foundation; either version 2 of the License, or - (at your option) any later version. - - This program is distributed in the hope that it will be useful, - but WITHOUT ANY WARRANTY; without even the implied warranty of - MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the - GNU General Public License for more details. - - You should have received a copy of the GNU General Public License along - with this program; if not, write to the Free Software Foundation, Inc., - 51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. - - See the full license in the file "LICENSE" in the top level distribution directory -*************************************************************************************/ -/* END LEGAL */ -#include -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class PartialFractionFermion5D; - -NAMESPACE_END(Grid); - diff --git a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplD/PartialFractionFermion5DInstantiationGparityWilsonImplD.cc b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplD/PartialFractionFermion5DInstantiationGparityWilsonImplD.cc new file mode 120000 index 00000000..7f4cea71 --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplD/PartialFractionFermion5DInstantiationGparityWilsonImplD.cc @@ -0,0 +1 @@ +../PartialFractionFermion5DInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplD/WilsonCloverFermionInstantiationGparityWilsonImplD.cc b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplD/WilsonCloverFermionInstantiationGparityWilsonImplD.cc deleted file mode 100644 index af99dfb6..00000000 --- a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplD/WilsonCloverFermionInstantiationGparityWilsonImplD.cc +++ /dev/null @@ -1,40 +0,0 @@ -/************************************************************************************* - - Grid physics library, www.github.com/paboyle/Grid - - Source file: ./lib/qcd/action/fermion/WilsonCloverFermion.cc - - Copyright (C) 2017 - - Author: paboyle - Author: Guido Cossu - - 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 -#include -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class WilsonCloverFermion; - -NAMESPACE_END(Grid); diff --git a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplD/WilsonCloverFermionInstantiationGparityWilsonImplD.cc b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplD/WilsonCloverFermionInstantiationGparityWilsonImplD.cc new file mode 120000 index 00000000..9cc05107 --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplD/WilsonCloverFermionInstantiationGparityWilsonImplD.cc @@ -0,0 +1 @@ +../WilsonCloverFermionInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplD/WilsonFermion5DInstantiationGparityWilsonImplD.cc b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplD/WilsonFermion5DInstantiationGparityWilsonImplD.cc deleted file mode 100644 index 0dac989c..00000000 --- a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplD/WilsonFermion5DInstantiationGparityWilsonImplD.cc +++ /dev/null @@ -1,40 +0,0 @@ -/************************************************************************************* - -Grid physics library, www.github.com/paboyle/Grid - -Source file: ./lib/qcd/action/fermion/WilsonKernels.cc - -Copyright (C) 2015 - -Author: Peter Boyle -Author: Peter Boyle -Author: paboyle - -This program is free software; you can redistribute it and/or modify -it under the terms of the GNU General Public License as published by -the Free Software Foundation; either version 2 of the License, or -(at your option) any later version. - -This program is distributed in the hope that it will be useful, -but WITHOUT ANY WARRANTY; without even the implied warranty of -MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the -GNU General Public License for more details. - -You should have received a copy of the GNU General Public License along -with this program; if not, write to the Free Software Foundation, Inc., -51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. - -See the full license in the file "LICENSE" in the top level distribution -directory -*************************************************************************************/ -/* END LEGAL */ -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class WilsonFermion5D; - -NAMESPACE_END(Grid); - diff --git a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplD/WilsonFermion5DInstantiationGparityWilsonImplD.cc b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplD/WilsonFermion5DInstantiationGparityWilsonImplD.cc new file mode 120000 index 00000000..804d0884 --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplD/WilsonFermion5DInstantiationGparityWilsonImplD.cc @@ -0,0 +1 @@ +../WilsonFermion5DInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplD/WilsonFermionInstantiationGparityWilsonImplD.cc b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplD/WilsonFermionInstantiationGparityWilsonImplD.cc deleted file mode 100644 index 6fd9c5ca..00000000 --- a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplD/WilsonFermionInstantiationGparityWilsonImplD.cc +++ /dev/null @@ -1,40 +0,0 @@ -/************************************************************************************* - -Grid physics library, www.github.com/paboyle/Grid - -Source file: ./lib/qcd/action/fermion/WilsonKernels.cc - -Copyright (C) 2015 - -Author: Peter Boyle -Author: Peter Boyle -Author: paboyle - -This program is free software; you can redistribute it and/or modify -it under the terms of the GNU General Public License as published by -the Free Software Foundation; either version 2 of the License, or -(at your option) any later version. - -This program is distributed in the hope that it will be useful, -but WITHOUT ANY WARRANTY; without even the implied warranty of -MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the -GNU General Public License for more details. - -You should have received a copy of the GNU General Public License along -with this program; if not, write to the Free Software Foundation, Inc., -51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. - -See the full license in the file "LICENSE" in the top level distribution -directory -*************************************************************************************/ -/* END LEGAL */ -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class WilsonFermion; - -NAMESPACE_END(Grid); - diff --git a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplD/WilsonFermionInstantiationGparityWilsonImplD.cc b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplD/WilsonFermionInstantiationGparityWilsonImplD.cc new file mode 120000 index 00000000..5f6ab65e --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplD/WilsonFermionInstantiationGparityWilsonImplD.cc @@ -0,0 +1 @@ +../WilsonFermionInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplD/WilsonKernelsInstantiationGparityWilsonImplD.cc b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplD/WilsonKernelsInstantiationGparityWilsonImplD.cc deleted file mode 100644 index 75f143cb..00000000 --- a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplD/WilsonKernelsInstantiationGparityWilsonImplD.cc +++ /dev/null @@ -1,74 +0,0 @@ -/************************************************************************************* - -Grid physics library, www.github.com/paboyle/Grid - -Source file: ./lib/qcd/action/fermion/WilsonKernels.cc - -Copyright (C) 2015 - -Author: Peter Boyle -Author: Peter Boyle -Author: paboyle - -This program is free software; you can redistribute it and/or modify -it under the terms of the GNU General Public License as published by -the Free Software Foundation; either version 2 of the License, or -(at your option) any later version. - -This program is distributed in the hope that it will be useful, -but WITHOUT ANY WARRANTY; without even the implied warranty of -MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the -GNU General Public License for more details. - -You should have received a copy of the GNU General Public License along -with this program; if not, write to the Free Software Foundation, Inc., -51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. - -See the full license in the file "LICENSE" in the top level distribution -directory -*************************************************************************************/ -/* END LEGAL */ -#include -#include -#include -#include -#include - -NAMESPACE_BEGIN(Grid); - -// Move these - -#include "impl.h" - -// G-parity requires more specialised implementation. -template <> -void WilsonKernels::ContractConservedCurrentSiteFwd(const SitePropagator &q_in_1, - const SitePropagator &q_in_2, - SitePropagator &q_out, - DoubledGaugeFieldView &U, - unsigned int sU, - unsigned int mu, - bool switch_sign) -{ - assert(0); -} -template <> -void WilsonKernels::ContractConservedCurrentSiteBwd( const SitePropagator &q_in_1, - const SitePropagator &q_in_2, - SitePropagator &q_out, - DoubledGaugeFieldView &U, - unsigned int mu, - unsigned int sU, - bool switch_sign) -{ - assert(0); -} - -HAND_SPECIALISE_GPARITY(IMPLEMENTATION); - - -template class WilsonKernels; - - -NAMESPACE_END(Grid); - diff --git a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplD/WilsonKernelsInstantiationGparityWilsonImplD.cc b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplD/WilsonKernelsInstantiationGparityWilsonImplD.cc new file mode 120000 index 00000000..87adea48 --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplD/WilsonKernelsInstantiationGparityWilsonImplD.cc @@ -0,0 +1 @@ +../WilsonKernelsInstantiationGparity.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplD/WilsonTMFermionInstantiationGparityWilsonImplD.cc b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplD/WilsonTMFermionInstantiationGparityWilsonImplD.cc deleted file mode 100644 index adfa310c..00000000 --- a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplD/WilsonTMFermionInstantiationGparityWilsonImplD.cc +++ /dev/null @@ -1,37 +0,0 @@ -/************************************************************************************* - - Grid physics library, www.github.com/paboyle/Grid - - Source file: ./lib/qcd/action/fermion/WilsonTMFermion.cc - - Copyright (C) 2015 - -Author: paboyle - - This program is free software; you can redistribute it and/or modify - it under the terms of the GNU General Public License as published by - the Free Software Foundation; either version 2 of the License, or - (at your option) any later version. - - This program is 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 -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class WilsonTMFermion; - -NAMESPACE_END(Grid); diff --git a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplD/WilsonTMFermionInstantiationGparityWilsonImplD.cc b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplD/WilsonTMFermionInstantiationGparityWilsonImplD.cc new file mode 120000 index 00000000..d5789bcf --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplD/WilsonTMFermionInstantiationGparityWilsonImplD.cc @@ -0,0 +1 @@ +../WilsonTMFermionInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplDF/CayleyFermion5DInstantiationGparityWilsonImplDF.cc b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplDF/CayleyFermion5DInstantiationGparityWilsonImplDF.cc deleted file mode 100644 index 5130db9c..00000000 --- a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplDF/CayleyFermion5DInstantiationGparityWilsonImplDF.cc +++ /dev/null @@ -1,44 +0,0 @@ -/************************************************************************************* - -Grid physics library, www.github.com/paboyle/Grid - -Source file: ./lib/qcd/action/fermion/WilsonKernels.cc - -Copyright (C) 2015 - -Author: Peter Boyle -Author: Peter Boyle -Author: paboyle - -This program is free software; you can redistribute it and/or modify -it under the terms of the GNU General Public License as published by -the Free Software Foundation; either version 2 of the License, or -(at your option) any later version. - -This program is distributed in the hope that it will be useful, -but WITHOUT ANY WARRANTY; without even the implied warranty of -MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the -GNU General Public License for more details. - -You should have received a copy of the GNU General Public License along -with this program; if not, write to the Free Software Foundation, Inc., -51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. - -See the full license in the file "LICENSE" in the top level distribution -directory -*************************************************************************************/ -/* END LEGAL */ -#include -#include -#include - - //#include - //#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class CayleyFermion5D; - -NAMESPACE_END(Grid); - diff --git a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplDF/CayleyFermion5DInstantiationGparityWilsonImplDF.cc b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplDF/CayleyFermion5DInstantiationGparityWilsonImplDF.cc new file mode 120000 index 00000000..cb1db625 --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplDF/CayleyFermion5DInstantiationGparityWilsonImplDF.cc @@ -0,0 +1 @@ +../CayleyFermion5DInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplDF/ContinuedFractionFermion5DInstantiationGparityWilsonImplDF.cc b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplDF/ContinuedFractionFermion5DInstantiationGparityWilsonImplDF.cc deleted file mode 100644 index ca0d6cea..00000000 --- a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplDF/ContinuedFractionFermion5DInstantiationGparityWilsonImplDF.cc +++ /dev/null @@ -1,38 +0,0 @@ -/************************************************************************************* - - Grid physics library, www.github.com/paboyle/Grid - - Source file: ./lib/qcd/action/fermion/ContinuedFractionFermion5D.cc - - Copyright (C) 2015 - -Author: Peter Boyle -Author: Peter Boyle - - This program is free software; you can redistribute it and/or modify - it under the terms of the GNU General Public License as published by - the Free Software Foundation; either version 2 of the License, or - (at your option) any later version. - - This program is distributed in the hope that it will be useful, - but WITHOUT ANY WARRANTY; without even the implied warranty of - MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the - GNU General Public License for more details. - - You should have received a copy of the GNU General Public License along - with this program; if not, write to the Free Software Foundation, Inc., - 51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. - - See the full license in the file "LICENSE" in the top level distribution directory -*************************************************************************************/ -/* END LEGAL */ -#include -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class ContinuedFractionFermion5D; - -NAMESPACE_END(Grid); diff --git a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplDF/ContinuedFractionFermion5DInstantiationGparityWilsonImplDF.cc b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplDF/ContinuedFractionFermion5DInstantiationGparityWilsonImplDF.cc new file mode 120000 index 00000000..c2d4b8fc --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplDF/ContinuedFractionFermion5DInstantiationGparityWilsonImplDF.cc @@ -0,0 +1 @@ +../ContinuedFractionFermion5DInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplDF/DomainWallEOFAFermionInstantiationGparityWilsonImplDF.cc b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplDF/DomainWallEOFAFermionInstantiationGparityWilsonImplDF.cc deleted file mode 100644 index f7198131..00000000 --- a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplDF/DomainWallEOFAFermionInstantiationGparityWilsonImplDF.cc +++ /dev/null @@ -1,44 +0,0 @@ -/************************************************************************************* - -Grid physics library, www.github.com/paboyle/Grid - -Source file: ./lib/qcd/action/fermion/DomainWallEOFAFermion.cc - -Copyright (C) 2017 - -Author: Peter Boyle -Author: Peter Boyle -Author: Peter Boyle -Author: paboyle -Author: David Murphy - -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 -#include -#include -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class DomainWallEOFAFermion; - -NAMESPACE_END(Grid); diff --git a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplDF/DomainWallEOFAFermionInstantiationGparityWilsonImplDF.cc b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplDF/DomainWallEOFAFermionInstantiationGparityWilsonImplDF.cc new file mode 120000 index 00000000..2f550a2b --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplDF/DomainWallEOFAFermionInstantiationGparityWilsonImplDF.cc @@ -0,0 +1 @@ +../DomainWallEOFAFermionInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplDF/MobiusEOFAFermionInstantiationGparityWilsonImplDF.cc b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplDF/MobiusEOFAFermionInstantiationGparityWilsonImplDF.cc deleted file mode 100644 index ce7eaac9..00000000 --- a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplDF/MobiusEOFAFermionInstantiationGparityWilsonImplDF.cc +++ /dev/null @@ -1,44 +0,0 @@ -/************************************************************************************* - -Grid physics library, www.github.com/paboyle/Grid - -Source file: ./lib/qcd/action/fermion/MobiusEOFAFermion.cc - -Copyright (C) 2017 - -Author: Peter Boyle -Author: Peter Boyle -Author: Peter Boyle -Author: paboyle -Author: David Murphy - -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 -#include -#include -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class MobiusEOFAFermion; - -NAMESPACE_END(Grid); diff --git a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplDF/MobiusEOFAFermionInstantiationGparityWilsonImplDF.cc b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplDF/MobiusEOFAFermionInstantiationGparityWilsonImplDF.cc new file mode 120000 index 00000000..7a8f1172 --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplDF/MobiusEOFAFermionInstantiationGparityWilsonImplDF.cc @@ -0,0 +1 @@ +../MobiusEOFAFermionInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplDF/PartialFractionFermion5DInstantiationGparityWilsonImplDF.cc b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplDF/PartialFractionFermion5DInstantiationGparityWilsonImplDF.cc deleted file mode 100644 index 757719b6..00000000 --- a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplDF/PartialFractionFermion5DInstantiationGparityWilsonImplDF.cc +++ /dev/null @@ -1,39 +0,0 @@ -/************************************************************************************* - - Grid physics library, www.github.com/paboyle/Grid - - Source file: ./lib/qcd/action/fermion/PartialFractionFermion5D.cc - - Copyright (C) 2015 - -Author: Peter Boyle -Author: Peter Boyle - - This program is free software; you can redistribute it and/or modify - it under the terms of the GNU General Public License as published by - the Free Software Foundation; either version 2 of the License, or - (at your option) any later version. - - This program is distributed in the hope that it will be useful, - but WITHOUT ANY WARRANTY; without even the implied warranty of - MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the - GNU General Public License for more details. - - You should have received a copy of the GNU General Public License along - with this program; if not, write to the Free Software Foundation, Inc., - 51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. - - See the full license in the file "LICENSE" in the top level distribution directory -*************************************************************************************/ -/* END LEGAL */ -#include -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class PartialFractionFermion5D; - -NAMESPACE_END(Grid); - diff --git a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplDF/PartialFractionFermion5DInstantiationGparityWilsonImplDF.cc b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplDF/PartialFractionFermion5DInstantiationGparityWilsonImplDF.cc new file mode 120000 index 00000000..7f4cea71 --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplDF/PartialFractionFermion5DInstantiationGparityWilsonImplDF.cc @@ -0,0 +1 @@ +../PartialFractionFermion5DInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplDF/WilsonCloverFermionInstantiationGparityWilsonImplDF.cc b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplDF/WilsonCloverFermionInstantiationGparityWilsonImplDF.cc deleted file mode 100644 index af99dfb6..00000000 --- a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplDF/WilsonCloverFermionInstantiationGparityWilsonImplDF.cc +++ /dev/null @@ -1,40 +0,0 @@ -/************************************************************************************* - - Grid physics library, www.github.com/paboyle/Grid - - Source file: ./lib/qcd/action/fermion/WilsonCloverFermion.cc - - Copyright (C) 2017 - - Author: paboyle - Author: Guido Cossu - - 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 -#include -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class WilsonCloverFermion; - -NAMESPACE_END(Grid); diff --git a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplDF/WilsonCloverFermionInstantiationGparityWilsonImplDF.cc b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplDF/WilsonCloverFermionInstantiationGparityWilsonImplDF.cc new file mode 120000 index 00000000..9cc05107 --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplDF/WilsonCloverFermionInstantiationGparityWilsonImplDF.cc @@ -0,0 +1 @@ +../WilsonCloverFermionInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplDF/WilsonFermion5DInstantiationGparityWilsonImplDF.cc b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplDF/WilsonFermion5DInstantiationGparityWilsonImplDF.cc deleted file mode 100644 index 0dac989c..00000000 --- a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplDF/WilsonFermion5DInstantiationGparityWilsonImplDF.cc +++ /dev/null @@ -1,40 +0,0 @@ -/************************************************************************************* - -Grid physics library, www.github.com/paboyle/Grid - -Source file: ./lib/qcd/action/fermion/WilsonKernels.cc - -Copyright (C) 2015 - -Author: Peter Boyle -Author: Peter Boyle -Author: paboyle - -This program is free software; you can redistribute it and/or modify -it under the terms of the GNU General Public License as published by -the Free Software Foundation; either version 2 of the License, or -(at your option) any later version. - -This program is distributed in the hope that it will be useful, -but WITHOUT ANY WARRANTY; without even the implied warranty of -MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the -GNU General Public License for more details. - -You should have received a copy of the GNU General Public License along -with this program; if not, write to the Free Software Foundation, Inc., -51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. - -See the full license in the file "LICENSE" in the top level distribution -directory -*************************************************************************************/ -/* END LEGAL */ -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class WilsonFermion5D; - -NAMESPACE_END(Grid); - diff --git a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplDF/WilsonFermion5DInstantiationGparityWilsonImplDF.cc b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplDF/WilsonFermion5DInstantiationGparityWilsonImplDF.cc new file mode 120000 index 00000000..804d0884 --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplDF/WilsonFermion5DInstantiationGparityWilsonImplDF.cc @@ -0,0 +1 @@ +../WilsonFermion5DInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplDF/WilsonFermionInstantiationGparityWilsonImplDF.cc b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplDF/WilsonFermionInstantiationGparityWilsonImplDF.cc deleted file mode 100644 index 6fd9c5ca..00000000 --- a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplDF/WilsonFermionInstantiationGparityWilsonImplDF.cc +++ /dev/null @@ -1,40 +0,0 @@ -/************************************************************************************* - -Grid physics library, www.github.com/paboyle/Grid - -Source file: ./lib/qcd/action/fermion/WilsonKernels.cc - -Copyright (C) 2015 - -Author: Peter Boyle -Author: Peter Boyle -Author: paboyle - -This program is free software; you can redistribute it and/or modify -it under the terms of the GNU General Public License as published by -the Free Software Foundation; either version 2 of the License, or -(at your option) any later version. - -This program is distributed in the hope that it will be useful, -but WITHOUT ANY WARRANTY; without even the implied warranty of -MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the -GNU General Public License for more details. - -You should have received a copy of the GNU General Public License along -with this program; if not, write to the Free Software Foundation, Inc., -51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. - -See the full license in the file "LICENSE" in the top level distribution -directory -*************************************************************************************/ -/* END LEGAL */ -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class WilsonFermion; - -NAMESPACE_END(Grid); - diff --git a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplDF/WilsonFermionInstantiationGparityWilsonImplDF.cc b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplDF/WilsonFermionInstantiationGparityWilsonImplDF.cc new file mode 120000 index 00000000..5f6ab65e --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplDF/WilsonFermionInstantiationGparityWilsonImplDF.cc @@ -0,0 +1 @@ +../WilsonFermionInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplDF/WilsonKernelsInstantiationGparityWilsonImplDF.cc b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplDF/WilsonKernelsInstantiationGparityWilsonImplDF.cc deleted file mode 100644 index 75f143cb..00000000 --- a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplDF/WilsonKernelsInstantiationGparityWilsonImplDF.cc +++ /dev/null @@ -1,74 +0,0 @@ -/************************************************************************************* - -Grid physics library, www.github.com/paboyle/Grid - -Source file: ./lib/qcd/action/fermion/WilsonKernels.cc - -Copyright (C) 2015 - -Author: Peter Boyle -Author: Peter Boyle -Author: paboyle - -This program is free software; you can redistribute it and/or modify -it under the terms of the GNU General Public License as published by -the Free Software Foundation; either version 2 of the License, or -(at your option) any later version. - -This program is distributed in the hope that it will be useful, -but WITHOUT ANY WARRANTY; without even the implied warranty of -MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the -GNU General Public License for more details. - -You should have received a copy of the GNU General Public License along -with this program; if not, write to the Free Software Foundation, Inc., -51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. - -See the full license in the file "LICENSE" in the top level distribution -directory -*************************************************************************************/ -/* END LEGAL */ -#include -#include -#include -#include -#include - -NAMESPACE_BEGIN(Grid); - -// Move these - -#include "impl.h" - -// G-parity requires more specialised implementation. -template <> -void WilsonKernels::ContractConservedCurrentSiteFwd(const SitePropagator &q_in_1, - const SitePropagator &q_in_2, - SitePropagator &q_out, - DoubledGaugeFieldView &U, - unsigned int sU, - unsigned int mu, - bool switch_sign) -{ - assert(0); -} -template <> -void WilsonKernels::ContractConservedCurrentSiteBwd( const SitePropagator &q_in_1, - const SitePropagator &q_in_2, - SitePropagator &q_out, - DoubledGaugeFieldView &U, - unsigned int mu, - unsigned int sU, - bool switch_sign) -{ - assert(0); -} - -HAND_SPECIALISE_GPARITY(IMPLEMENTATION); - - -template class WilsonKernels; - - -NAMESPACE_END(Grid); - diff --git a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplDF/WilsonKernelsInstantiationGparityWilsonImplDF.cc b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplDF/WilsonKernelsInstantiationGparityWilsonImplDF.cc new file mode 120000 index 00000000..87adea48 --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplDF/WilsonKernelsInstantiationGparityWilsonImplDF.cc @@ -0,0 +1 @@ +../WilsonKernelsInstantiationGparity.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplDF/WilsonTMFermionInstantiationGparityWilsonImplDF.cc b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplDF/WilsonTMFermionInstantiationGparityWilsonImplDF.cc deleted file mode 100644 index adfa310c..00000000 --- a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplDF/WilsonTMFermionInstantiationGparityWilsonImplDF.cc +++ /dev/null @@ -1,37 +0,0 @@ -/************************************************************************************* - - Grid physics library, www.github.com/paboyle/Grid - - Source file: ./lib/qcd/action/fermion/WilsonTMFermion.cc - - Copyright (C) 2015 - -Author: paboyle - - This program is free software; you can redistribute it and/or modify - it under the terms of the GNU General Public License as published by - the Free Software Foundation; either version 2 of the License, or - (at your option) any later version. - - This program is 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 -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class WilsonTMFermion; - -NAMESPACE_END(Grid); diff --git a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplDF/WilsonTMFermionInstantiationGparityWilsonImplDF.cc b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplDF/WilsonTMFermionInstantiationGparityWilsonImplDF.cc new file mode 120000 index 00000000..d5789bcf --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplDF/WilsonTMFermionInstantiationGparityWilsonImplDF.cc @@ -0,0 +1 @@ +../WilsonTMFermionInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplF/CayleyFermion5DInstantiationGparityWilsonImplF.cc b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplF/CayleyFermion5DInstantiationGparityWilsonImplF.cc deleted file mode 100644 index 5130db9c..00000000 --- a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplF/CayleyFermion5DInstantiationGparityWilsonImplF.cc +++ /dev/null @@ -1,44 +0,0 @@ -/************************************************************************************* - -Grid physics library, www.github.com/paboyle/Grid - -Source file: ./lib/qcd/action/fermion/WilsonKernels.cc - -Copyright (C) 2015 - -Author: Peter Boyle -Author: Peter Boyle -Author: paboyle - -This program is free software; you can redistribute it and/or modify -it under the terms of the GNU General Public License as published by -the Free Software Foundation; either version 2 of the License, or -(at your option) any later version. - -This program is distributed in the hope that it will be useful, -but WITHOUT ANY WARRANTY; without even the implied warranty of -MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the -GNU General Public License for more details. - -You should have received a copy of the GNU General Public License along -with this program; if not, write to the Free Software Foundation, Inc., -51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. - -See the full license in the file "LICENSE" in the top level distribution -directory -*************************************************************************************/ -/* END LEGAL */ -#include -#include -#include - - //#include - //#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class CayleyFermion5D; - -NAMESPACE_END(Grid); - diff --git a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplF/CayleyFermion5DInstantiationGparityWilsonImplF.cc b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplF/CayleyFermion5DInstantiationGparityWilsonImplF.cc new file mode 120000 index 00000000..cb1db625 --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplF/CayleyFermion5DInstantiationGparityWilsonImplF.cc @@ -0,0 +1 @@ +../CayleyFermion5DInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplF/ContinuedFractionFermion5DInstantiationGparityWilsonImplF.cc b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplF/ContinuedFractionFermion5DInstantiationGparityWilsonImplF.cc deleted file mode 100644 index ca0d6cea..00000000 --- a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplF/ContinuedFractionFermion5DInstantiationGparityWilsonImplF.cc +++ /dev/null @@ -1,38 +0,0 @@ -/************************************************************************************* - - Grid physics library, www.github.com/paboyle/Grid - - Source file: ./lib/qcd/action/fermion/ContinuedFractionFermion5D.cc - - Copyright (C) 2015 - -Author: Peter Boyle -Author: Peter Boyle - - This program is free software; you can redistribute it and/or modify - it under the terms of the GNU General Public License as published by - the Free Software Foundation; either version 2 of the License, or - (at your option) any later version. - - This program is distributed in the hope that it will be useful, - but WITHOUT ANY WARRANTY; without even the implied warranty of - MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the - GNU General Public License for more details. - - You should have received a copy of the GNU General Public License along - with this program; if not, write to the Free Software Foundation, Inc., - 51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. - - See the full license in the file "LICENSE" in the top level distribution directory -*************************************************************************************/ -/* END LEGAL */ -#include -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class ContinuedFractionFermion5D; - -NAMESPACE_END(Grid); diff --git a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplF/ContinuedFractionFermion5DInstantiationGparityWilsonImplF.cc b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplF/ContinuedFractionFermion5DInstantiationGparityWilsonImplF.cc new file mode 120000 index 00000000..c2d4b8fc --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplF/ContinuedFractionFermion5DInstantiationGparityWilsonImplF.cc @@ -0,0 +1 @@ +../ContinuedFractionFermion5DInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplF/DomainWallEOFAFermionInstantiationGparityWilsonImplF.cc b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplF/DomainWallEOFAFermionInstantiationGparityWilsonImplF.cc deleted file mode 100644 index f7198131..00000000 --- a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplF/DomainWallEOFAFermionInstantiationGparityWilsonImplF.cc +++ /dev/null @@ -1,44 +0,0 @@ -/************************************************************************************* - -Grid physics library, www.github.com/paboyle/Grid - -Source file: ./lib/qcd/action/fermion/DomainWallEOFAFermion.cc - -Copyright (C) 2017 - -Author: Peter Boyle -Author: Peter Boyle -Author: Peter Boyle -Author: paboyle -Author: David Murphy - -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 -#include -#include -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class DomainWallEOFAFermion; - -NAMESPACE_END(Grid); diff --git a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplF/DomainWallEOFAFermionInstantiationGparityWilsonImplF.cc b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplF/DomainWallEOFAFermionInstantiationGparityWilsonImplF.cc new file mode 120000 index 00000000..2f550a2b --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplF/DomainWallEOFAFermionInstantiationGparityWilsonImplF.cc @@ -0,0 +1 @@ +../DomainWallEOFAFermionInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplF/MobiusEOFAFermionInstantiationGparityWilsonImplF.cc b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplF/MobiusEOFAFermionInstantiationGparityWilsonImplF.cc deleted file mode 100644 index ce7eaac9..00000000 --- a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplF/MobiusEOFAFermionInstantiationGparityWilsonImplF.cc +++ /dev/null @@ -1,44 +0,0 @@ -/************************************************************************************* - -Grid physics library, www.github.com/paboyle/Grid - -Source file: ./lib/qcd/action/fermion/MobiusEOFAFermion.cc - -Copyright (C) 2017 - -Author: Peter Boyle -Author: Peter Boyle -Author: Peter Boyle -Author: paboyle -Author: David Murphy - -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 -#include -#include -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class MobiusEOFAFermion; - -NAMESPACE_END(Grid); diff --git a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplF/MobiusEOFAFermionInstantiationGparityWilsonImplF.cc b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplF/MobiusEOFAFermionInstantiationGparityWilsonImplF.cc new file mode 120000 index 00000000..7a8f1172 --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplF/MobiusEOFAFermionInstantiationGparityWilsonImplF.cc @@ -0,0 +1 @@ +../MobiusEOFAFermionInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplF/PartialFractionFermion5DInstantiationGparityWilsonImplF.cc b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplF/PartialFractionFermion5DInstantiationGparityWilsonImplF.cc deleted file mode 100644 index 757719b6..00000000 --- a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplF/PartialFractionFermion5DInstantiationGparityWilsonImplF.cc +++ /dev/null @@ -1,39 +0,0 @@ -/************************************************************************************* - - Grid physics library, www.github.com/paboyle/Grid - - Source file: ./lib/qcd/action/fermion/PartialFractionFermion5D.cc - - Copyright (C) 2015 - -Author: Peter Boyle -Author: Peter Boyle - - This program is free software; you can redistribute it and/or modify - it under the terms of the GNU General Public License as published by - the Free Software Foundation; either version 2 of the License, or - (at your option) any later version. - - This program is distributed in the hope that it will be useful, - but WITHOUT ANY WARRANTY; without even the implied warranty of - MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the - GNU General Public License for more details. - - You should have received a copy of the GNU General Public License along - with this program; if not, write to the Free Software Foundation, Inc., - 51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. - - See the full license in the file "LICENSE" in the top level distribution directory -*************************************************************************************/ -/* END LEGAL */ -#include -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class PartialFractionFermion5D; - -NAMESPACE_END(Grid); - diff --git a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplF/PartialFractionFermion5DInstantiationGparityWilsonImplF.cc b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplF/PartialFractionFermion5DInstantiationGparityWilsonImplF.cc new file mode 120000 index 00000000..7f4cea71 --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplF/PartialFractionFermion5DInstantiationGparityWilsonImplF.cc @@ -0,0 +1 @@ +../PartialFractionFermion5DInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplF/WilsonCloverFermionInstantiationGparityWilsonImplF.cc b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplF/WilsonCloverFermionInstantiationGparityWilsonImplF.cc deleted file mode 100644 index af99dfb6..00000000 --- a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplF/WilsonCloverFermionInstantiationGparityWilsonImplF.cc +++ /dev/null @@ -1,40 +0,0 @@ -/************************************************************************************* - - Grid physics library, www.github.com/paboyle/Grid - - Source file: ./lib/qcd/action/fermion/WilsonCloverFermion.cc - - Copyright (C) 2017 - - Author: paboyle - Author: Guido Cossu - - 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 -#include -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class WilsonCloverFermion; - -NAMESPACE_END(Grid); diff --git a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplF/WilsonCloverFermionInstantiationGparityWilsonImplF.cc b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplF/WilsonCloverFermionInstantiationGparityWilsonImplF.cc new file mode 120000 index 00000000..9cc05107 --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplF/WilsonCloverFermionInstantiationGparityWilsonImplF.cc @@ -0,0 +1 @@ +../WilsonCloverFermionInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplF/WilsonFermion5DInstantiationGparityWilsonImplF.cc b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplF/WilsonFermion5DInstantiationGparityWilsonImplF.cc deleted file mode 100644 index 0dac989c..00000000 --- a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplF/WilsonFermion5DInstantiationGparityWilsonImplF.cc +++ /dev/null @@ -1,40 +0,0 @@ -/************************************************************************************* - -Grid physics library, www.github.com/paboyle/Grid - -Source file: ./lib/qcd/action/fermion/WilsonKernels.cc - -Copyright (C) 2015 - -Author: Peter Boyle -Author: Peter Boyle -Author: paboyle - -This program is free software; you can redistribute it and/or modify -it under the terms of the GNU General Public License as published by -the Free Software Foundation; either version 2 of the License, or -(at your option) any later version. - -This program is distributed in the hope that it will be useful, -but WITHOUT ANY WARRANTY; without even the implied warranty of -MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the -GNU General Public License for more details. - -You should have received a copy of the GNU General Public License along -with this program; if not, write to the Free Software Foundation, Inc., -51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. - -See the full license in the file "LICENSE" in the top level distribution -directory -*************************************************************************************/ -/* END LEGAL */ -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class WilsonFermion5D; - -NAMESPACE_END(Grid); - diff --git a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplF/WilsonFermion5DInstantiationGparityWilsonImplF.cc b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplF/WilsonFermion5DInstantiationGparityWilsonImplF.cc new file mode 120000 index 00000000..804d0884 --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplF/WilsonFermion5DInstantiationGparityWilsonImplF.cc @@ -0,0 +1 @@ +../WilsonFermion5DInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplF/WilsonFermionInstantiationGparityWilsonImplF.cc b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplF/WilsonFermionInstantiationGparityWilsonImplF.cc deleted file mode 100644 index 6fd9c5ca..00000000 --- a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplF/WilsonFermionInstantiationGparityWilsonImplF.cc +++ /dev/null @@ -1,40 +0,0 @@ -/************************************************************************************* - -Grid physics library, www.github.com/paboyle/Grid - -Source file: ./lib/qcd/action/fermion/WilsonKernels.cc - -Copyright (C) 2015 - -Author: Peter Boyle -Author: Peter Boyle -Author: paboyle - -This program is free software; you can redistribute it and/or modify -it under the terms of the GNU General Public License as published by -the Free Software Foundation; either version 2 of the License, or -(at your option) any later version. - -This program is distributed in the hope that it will be useful, -but WITHOUT ANY WARRANTY; without even the implied warranty of -MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the -GNU General Public License for more details. - -You should have received a copy of the GNU General Public License along -with this program; if not, write to the Free Software Foundation, Inc., -51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. - -See the full license in the file "LICENSE" in the top level distribution -directory -*************************************************************************************/ -/* END LEGAL */ -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class WilsonFermion; - -NAMESPACE_END(Grid); - diff --git a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplF/WilsonFermionInstantiationGparityWilsonImplF.cc b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplF/WilsonFermionInstantiationGparityWilsonImplF.cc new file mode 120000 index 00000000..5f6ab65e --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplF/WilsonFermionInstantiationGparityWilsonImplF.cc @@ -0,0 +1 @@ +../WilsonFermionInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplF/WilsonKernelsInstantiationGparityWilsonImplF.cc b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplF/WilsonKernelsInstantiationGparityWilsonImplF.cc deleted file mode 100644 index 75f143cb..00000000 --- a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplF/WilsonKernelsInstantiationGparityWilsonImplF.cc +++ /dev/null @@ -1,74 +0,0 @@ -/************************************************************************************* - -Grid physics library, www.github.com/paboyle/Grid - -Source file: ./lib/qcd/action/fermion/WilsonKernels.cc - -Copyright (C) 2015 - -Author: Peter Boyle -Author: Peter Boyle -Author: paboyle - -This program is free software; you can redistribute it and/or modify -it under the terms of the GNU General Public License as published by -the Free Software Foundation; either version 2 of the License, or -(at your option) any later version. - -This program is distributed in the hope that it will be useful, -but WITHOUT ANY WARRANTY; without even the implied warranty of -MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the -GNU General Public License for more details. - -You should have received a copy of the GNU General Public License along -with this program; if not, write to the Free Software Foundation, Inc., -51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. - -See the full license in the file "LICENSE" in the top level distribution -directory -*************************************************************************************/ -/* END LEGAL */ -#include -#include -#include -#include -#include - -NAMESPACE_BEGIN(Grid); - -// Move these - -#include "impl.h" - -// G-parity requires more specialised implementation. -template <> -void WilsonKernels::ContractConservedCurrentSiteFwd(const SitePropagator &q_in_1, - const SitePropagator &q_in_2, - SitePropagator &q_out, - DoubledGaugeFieldView &U, - unsigned int sU, - unsigned int mu, - bool switch_sign) -{ - assert(0); -} -template <> -void WilsonKernels::ContractConservedCurrentSiteBwd( const SitePropagator &q_in_1, - const SitePropagator &q_in_2, - SitePropagator &q_out, - DoubledGaugeFieldView &U, - unsigned int mu, - unsigned int sU, - bool switch_sign) -{ - assert(0); -} - -HAND_SPECIALISE_GPARITY(IMPLEMENTATION); - - -template class WilsonKernels; - - -NAMESPACE_END(Grid); - diff --git a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplF/WilsonKernelsInstantiationGparityWilsonImplF.cc b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplF/WilsonKernelsInstantiationGparityWilsonImplF.cc new file mode 120000 index 00000000..87adea48 --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplF/WilsonKernelsInstantiationGparityWilsonImplF.cc @@ -0,0 +1 @@ +../WilsonKernelsInstantiationGparity.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplF/WilsonTMFermionInstantiationGparityWilsonImplF.cc b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplF/WilsonTMFermionInstantiationGparityWilsonImplF.cc deleted file mode 100644 index adfa310c..00000000 --- a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplF/WilsonTMFermionInstantiationGparityWilsonImplF.cc +++ /dev/null @@ -1,37 +0,0 @@ -/************************************************************************************* - - Grid physics library, www.github.com/paboyle/Grid - - Source file: ./lib/qcd/action/fermion/WilsonTMFermion.cc - - Copyright (C) 2015 - -Author: paboyle - - This program is free software; you can redistribute it and/or modify - it under the terms of the GNU General Public License as published by - the Free Software Foundation; either version 2 of the License, or - (at your option) any later version. - - This program is 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 -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class WilsonTMFermion; - -NAMESPACE_END(Grid); diff --git a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplF/WilsonTMFermionInstantiationGparityWilsonImplF.cc b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplF/WilsonTMFermionInstantiationGparityWilsonImplF.cc new file mode 120000 index 00000000..d5789bcf --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplF/WilsonTMFermionInstantiationGparityWilsonImplF.cc @@ -0,0 +1 @@ +../WilsonTMFermionInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplFH/CayleyFermion5DInstantiationGparityWilsonImplFH.cc b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplFH/CayleyFermion5DInstantiationGparityWilsonImplFH.cc deleted file mode 100644 index 5130db9c..00000000 --- a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplFH/CayleyFermion5DInstantiationGparityWilsonImplFH.cc +++ /dev/null @@ -1,44 +0,0 @@ -/************************************************************************************* - -Grid physics library, www.github.com/paboyle/Grid - -Source file: ./lib/qcd/action/fermion/WilsonKernels.cc - -Copyright (C) 2015 - -Author: Peter Boyle -Author: Peter Boyle -Author: paboyle - -This program is free software; you can redistribute it and/or modify -it under the terms of the GNU General Public License as published by -the Free Software Foundation; either version 2 of the License, or -(at your option) any later version. - -This program is distributed in the hope that it will be useful, -but WITHOUT ANY WARRANTY; without even the implied warranty of -MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the -GNU General Public License for more details. - -You should have received a copy of the GNU General Public License along -with this program; if not, write to the Free Software Foundation, Inc., -51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. - -See the full license in the file "LICENSE" in the top level distribution -directory -*************************************************************************************/ -/* END LEGAL */ -#include -#include -#include - - //#include - //#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class CayleyFermion5D; - -NAMESPACE_END(Grid); - diff --git a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplFH/CayleyFermion5DInstantiationGparityWilsonImplFH.cc b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplFH/CayleyFermion5DInstantiationGparityWilsonImplFH.cc new file mode 120000 index 00000000..cb1db625 --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplFH/CayleyFermion5DInstantiationGparityWilsonImplFH.cc @@ -0,0 +1 @@ +../CayleyFermion5DInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplFH/ContinuedFractionFermion5DInstantiationGparityWilsonImplFH.cc b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplFH/ContinuedFractionFermion5DInstantiationGparityWilsonImplFH.cc deleted file mode 100644 index ca0d6cea..00000000 --- a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplFH/ContinuedFractionFermion5DInstantiationGparityWilsonImplFH.cc +++ /dev/null @@ -1,38 +0,0 @@ -/************************************************************************************* - - Grid physics library, www.github.com/paboyle/Grid - - Source file: ./lib/qcd/action/fermion/ContinuedFractionFermion5D.cc - - Copyright (C) 2015 - -Author: Peter Boyle -Author: Peter Boyle - - This program is free software; you can redistribute it and/or modify - it under the terms of the GNU General Public License as published by - the Free Software Foundation; either version 2 of the License, or - (at your option) any later version. - - This program is distributed in the hope that it will be useful, - but WITHOUT ANY WARRANTY; without even the implied warranty of - MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the - GNU General Public License for more details. - - You should have received a copy of the GNU General Public License along - with this program; if not, write to the Free Software Foundation, Inc., - 51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. - - See the full license in the file "LICENSE" in the top level distribution directory -*************************************************************************************/ -/* END LEGAL */ -#include -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class ContinuedFractionFermion5D; - -NAMESPACE_END(Grid); diff --git a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplFH/ContinuedFractionFermion5DInstantiationGparityWilsonImplFH.cc b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplFH/ContinuedFractionFermion5DInstantiationGparityWilsonImplFH.cc new file mode 120000 index 00000000..c2d4b8fc --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplFH/ContinuedFractionFermion5DInstantiationGparityWilsonImplFH.cc @@ -0,0 +1 @@ +../ContinuedFractionFermion5DInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplFH/DomainWallEOFAFermionInstantiationGparityWilsonImplFH.cc b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplFH/DomainWallEOFAFermionInstantiationGparityWilsonImplFH.cc deleted file mode 100644 index f7198131..00000000 --- a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplFH/DomainWallEOFAFermionInstantiationGparityWilsonImplFH.cc +++ /dev/null @@ -1,44 +0,0 @@ -/************************************************************************************* - -Grid physics library, www.github.com/paboyle/Grid - -Source file: ./lib/qcd/action/fermion/DomainWallEOFAFermion.cc - -Copyright (C) 2017 - -Author: Peter Boyle -Author: Peter Boyle -Author: Peter Boyle -Author: paboyle -Author: David Murphy - -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 -#include -#include -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class DomainWallEOFAFermion; - -NAMESPACE_END(Grid); diff --git a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplFH/DomainWallEOFAFermionInstantiationGparityWilsonImplFH.cc b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplFH/DomainWallEOFAFermionInstantiationGparityWilsonImplFH.cc new file mode 120000 index 00000000..2f550a2b --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplFH/DomainWallEOFAFermionInstantiationGparityWilsonImplFH.cc @@ -0,0 +1 @@ +../DomainWallEOFAFermionInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplFH/MobiusEOFAFermionInstantiationGparityWilsonImplFH.cc b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplFH/MobiusEOFAFermionInstantiationGparityWilsonImplFH.cc deleted file mode 100644 index ce7eaac9..00000000 --- a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplFH/MobiusEOFAFermionInstantiationGparityWilsonImplFH.cc +++ /dev/null @@ -1,44 +0,0 @@ -/************************************************************************************* - -Grid physics library, www.github.com/paboyle/Grid - -Source file: ./lib/qcd/action/fermion/MobiusEOFAFermion.cc - -Copyright (C) 2017 - -Author: Peter Boyle -Author: Peter Boyle -Author: Peter Boyle -Author: paboyle -Author: David Murphy - -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 -#include -#include -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class MobiusEOFAFermion; - -NAMESPACE_END(Grid); diff --git a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplFH/MobiusEOFAFermionInstantiationGparityWilsonImplFH.cc b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplFH/MobiusEOFAFermionInstantiationGparityWilsonImplFH.cc new file mode 120000 index 00000000..7a8f1172 --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplFH/MobiusEOFAFermionInstantiationGparityWilsonImplFH.cc @@ -0,0 +1 @@ +../MobiusEOFAFermionInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplFH/PartialFractionFermion5DInstantiationGparityWilsonImplFH.cc b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplFH/PartialFractionFermion5DInstantiationGparityWilsonImplFH.cc deleted file mode 100644 index 757719b6..00000000 --- a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplFH/PartialFractionFermion5DInstantiationGparityWilsonImplFH.cc +++ /dev/null @@ -1,39 +0,0 @@ -/************************************************************************************* - - Grid physics library, www.github.com/paboyle/Grid - - Source file: ./lib/qcd/action/fermion/PartialFractionFermion5D.cc - - Copyright (C) 2015 - -Author: Peter Boyle -Author: Peter Boyle - - This program is free software; you can redistribute it and/or modify - it under the terms of the GNU General Public License as published by - the Free Software Foundation; either version 2 of the License, or - (at your option) any later version. - - This program is distributed in the hope that it will be useful, - but WITHOUT ANY WARRANTY; without even the implied warranty of - MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the - GNU General Public License for more details. - - You should have received a copy of the GNU General Public License along - with this program; if not, write to the Free Software Foundation, Inc., - 51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. - - See the full license in the file "LICENSE" in the top level distribution directory -*************************************************************************************/ -/* END LEGAL */ -#include -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class PartialFractionFermion5D; - -NAMESPACE_END(Grid); - diff --git a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplFH/PartialFractionFermion5DInstantiationGparityWilsonImplFH.cc b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplFH/PartialFractionFermion5DInstantiationGparityWilsonImplFH.cc new file mode 120000 index 00000000..7f4cea71 --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplFH/PartialFractionFermion5DInstantiationGparityWilsonImplFH.cc @@ -0,0 +1 @@ +../PartialFractionFermion5DInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplFH/WilsonCloverFermionInstantiationGparityWilsonImplFH.cc b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplFH/WilsonCloverFermionInstantiationGparityWilsonImplFH.cc deleted file mode 100644 index af99dfb6..00000000 --- a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplFH/WilsonCloverFermionInstantiationGparityWilsonImplFH.cc +++ /dev/null @@ -1,40 +0,0 @@ -/************************************************************************************* - - Grid physics library, www.github.com/paboyle/Grid - - Source file: ./lib/qcd/action/fermion/WilsonCloverFermion.cc - - Copyright (C) 2017 - - Author: paboyle - Author: Guido Cossu - - 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 -#include -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class WilsonCloverFermion; - -NAMESPACE_END(Grid); diff --git a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplFH/WilsonCloverFermionInstantiationGparityWilsonImplFH.cc b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplFH/WilsonCloverFermionInstantiationGparityWilsonImplFH.cc new file mode 120000 index 00000000..9cc05107 --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplFH/WilsonCloverFermionInstantiationGparityWilsonImplFH.cc @@ -0,0 +1 @@ +../WilsonCloverFermionInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplFH/WilsonFermion5DInstantiationGparityWilsonImplFH.cc b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplFH/WilsonFermion5DInstantiationGparityWilsonImplFH.cc deleted file mode 100644 index 0dac989c..00000000 --- a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplFH/WilsonFermion5DInstantiationGparityWilsonImplFH.cc +++ /dev/null @@ -1,40 +0,0 @@ -/************************************************************************************* - -Grid physics library, www.github.com/paboyle/Grid - -Source file: ./lib/qcd/action/fermion/WilsonKernels.cc - -Copyright (C) 2015 - -Author: Peter Boyle -Author: Peter Boyle -Author: paboyle - -This program is free software; you can redistribute it and/or modify -it under the terms of the GNU General Public License as published by -the Free Software Foundation; either version 2 of the License, or -(at your option) any later version. - -This program is distributed in the hope that it will be useful, -but WITHOUT ANY WARRANTY; without even the implied warranty of -MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the -GNU General Public License for more details. - -You should have received a copy of the GNU General Public License along -with this program; if not, write to the Free Software Foundation, Inc., -51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. - -See the full license in the file "LICENSE" in the top level distribution -directory -*************************************************************************************/ -/* END LEGAL */ -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class WilsonFermion5D; - -NAMESPACE_END(Grid); - diff --git a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplFH/WilsonFermion5DInstantiationGparityWilsonImplFH.cc b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplFH/WilsonFermion5DInstantiationGparityWilsonImplFH.cc new file mode 120000 index 00000000..804d0884 --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplFH/WilsonFermion5DInstantiationGparityWilsonImplFH.cc @@ -0,0 +1 @@ +../WilsonFermion5DInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplFH/WilsonFermionInstantiationGparityWilsonImplFH.cc b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplFH/WilsonFermionInstantiationGparityWilsonImplFH.cc deleted file mode 100644 index 6fd9c5ca..00000000 --- a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplFH/WilsonFermionInstantiationGparityWilsonImplFH.cc +++ /dev/null @@ -1,40 +0,0 @@ -/************************************************************************************* - -Grid physics library, www.github.com/paboyle/Grid - -Source file: ./lib/qcd/action/fermion/WilsonKernels.cc - -Copyright (C) 2015 - -Author: Peter Boyle -Author: Peter Boyle -Author: paboyle - -This program is free software; you can redistribute it and/or modify -it under the terms of the GNU General Public License as published by -the Free Software Foundation; either version 2 of the License, or -(at your option) any later version. - -This program is distributed in the hope that it will be useful, -but WITHOUT ANY WARRANTY; without even the implied warranty of -MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the -GNU General Public License for more details. - -You should have received a copy of the GNU General Public License along -with this program; if not, write to the Free Software Foundation, Inc., -51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. - -See the full license in the file "LICENSE" in the top level distribution -directory -*************************************************************************************/ -/* END LEGAL */ -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class WilsonFermion; - -NAMESPACE_END(Grid); - diff --git a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplFH/WilsonFermionInstantiationGparityWilsonImplFH.cc b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplFH/WilsonFermionInstantiationGparityWilsonImplFH.cc new file mode 120000 index 00000000..5f6ab65e --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplFH/WilsonFermionInstantiationGparityWilsonImplFH.cc @@ -0,0 +1 @@ +../WilsonFermionInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplFH/WilsonKernelsInstantiationGparityWilsonImplFH.cc b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplFH/WilsonKernelsInstantiationGparityWilsonImplFH.cc deleted file mode 100644 index 75f143cb..00000000 --- a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplFH/WilsonKernelsInstantiationGparityWilsonImplFH.cc +++ /dev/null @@ -1,74 +0,0 @@ -/************************************************************************************* - -Grid physics library, www.github.com/paboyle/Grid - -Source file: ./lib/qcd/action/fermion/WilsonKernels.cc - -Copyright (C) 2015 - -Author: Peter Boyle -Author: Peter Boyle -Author: paboyle - -This program is free software; you can redistribute it and/or modify -it under the terms of the GNU General Public License as published by -the Free Software Foundation; either version 2 of the License, or -(at your option) any later version. - -This program is distributed in the hope that it will be useful, -but WITHOUT ANY WARRANTY; without even the implied warranty of -MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the -GNU General Public License for more details. - -You should have received a copy of the GNU General Public License along -with this program; if not, write to the Free Software Foundation, Inc., -51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. - -See the full license in the file "LICENSE" in the top level distribution -directory -*************************************************************************************/ -/* END LEGAL */ -#include -#include -#include -#include -#include - -NAMESPACE_BEGIN(Grid); - -// Move these - -#include "impl.h" - -// G-parity requires more specialised implementation. -template <> -void WilsonKernels::ContractConservedCurrentSiteFwd(const SitePropagator &q_in_1, - const SitePropagator &q_in_2, - SitePropagator &q_out, - DoubledGaugeFieldView &U, - unsigned int sU, - unsigned int mu, - bool switch_sign) -{ - assert(0); -} -template <> -void WilsonKernels::ContractConservedCurrentSiteBwd( const SitePropagator &q_in_1, - const SitePropagator &q_in_2, - SitePropagator &q_out, - DoubledGaugeFieldView &U, - unsigned int mu, - unsigned int sU, - bool switch_sign) -{ - assert(0); -} - -HAND_SPECIALISE_GPARITY(IMPLEMENTATION); - - -template class WilsonKernels; - - -NAMESPACE_END(Grid); - diff --git a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplFH/WilsonKernelsInstantiationGparityWilsonImplFH.cc b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplFH/WilsonKernelsInstantiationGparityWilsonImplFH.cc new file mode 120000 index 00000000..87adea48 --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplFH/WilsonKernelsInstantiationGparityWilsonImplFH.cc @@ -0,0 +1 @@ +../WilsonKernelsInstantiationGparity.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplFH/WilsonTMFermionInstantiationGparityWilsonImplFH.cc b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplFH/WilsonTMFermionInstantiationGparityWilsonImplFH.cc deleted file mode 100644 index adfa310c..00000000 --- a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplFH/WilsonTMFermionInstantiationGparityWilsonImplFH.cc +++ /dev/null @@ -1,37 +0,0 @@ -/************************************************************************************* - - Grid physics library, www.github.com/paboyle/Grid - - Source file: ./lib/qcd/action/fermion/WilsonTMFermion.cc - - Copyright (C) 2015 - -Author: paboyle - - This program is free software; you can redistribute it and/or modify - it under the terms of the GNU General Public License as published by - the Free Software Foundation; either version 2 of the License, or - (at your option) any later version. - - This program is 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 -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class WilsonTMFermion; - -NAMESPACE_END(Grid); diff --git a/Grid/qcd/action/fermion/instantiation/GparityWilsonImplFH/WilsonTMFermionInstantiationGparityWilsonImplFH.cc b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplFH/WilsonTMFermionInstantiationGparityWilsonImplFH.cc new file mode 120000 index 00000000..d5789bcf --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/GparityWilsonImplFH/WilsonTMFermionInstantiationGparityWilsonImplFH.cc @@ -0,0 +1 @@ +../WilsonTMFermionInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/StaggeredImplD/ImprovedStaggeredFermion5DInstantiationStaggeredImplD.cc b/Grid/qcd/action/fermion/instantiation/StaggeredImplD/ImprovedStaggeredFermion5DInstantiationStaggeredImplD.cc deleted file mode 100644 index 572b375c..00000000 --- a/Grid/qcd/action/fermion/instantiation/StaggeredImplD/ImprovedStaggeredFermion5DInstantiationStaggeredImplD.cc +++ /dev/null @@ -1,44 +0,0 @@ -/************************************************************************************* - - Grid physics library, www.github.com/paboyle/Grid - - Source file: ./lib/qcd/action/fermion/ImprovedStaggeredFermion5D.cc - - Copyright (C) 2015 - -Author: Azusa Yamaguchi -Author: Peter Boyle - - This program is free software; you can redistribute it and/or modify - it under the terms of the GNU General Public License as published by - 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 - -#include -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class ImprovedStaggeredFermion5D; - -NAMESPACE_END(Grid); - - - - diff --git a/Grid/qcd/action/fermion/instantiation/StaggeredImplD/ImprovedStaggeredFermion5DInstantiationStaggeredImplD.cc b/Grid/qcd/action/fermion/instantiation/StaggeredImplD/ImprovedStaggeredFermion5DInstantiationStaggeredImplD.cc new file mode 120000 index 00000000..a8082840 --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/StaggeredImplD/ImprovedStaggeredFermion5DInstantiationStaggeredImplD.cc @@ -0,0 +1 @@ +../ImprovedStaggeredFermion5DInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/StaggeredImplD/ImprovedStaggeredFermionInstantiationStaggeredImplD.cc b/Grid/qcd/action/fermion/instantiation/StaggeredImplD/ImprovedStaggeredFermionInstantiationStaggeredImplD.cc deleted file mode 100644 index d35b7349..00000000 --- a/Grid/qcd/action/fermion/instantiation/StaggeredImplD/ImprovedStaggeredFermionInstantiationStaggeredImplD.cc +++ /dev/null @@ -1,37 +0,0 @@ -/************************************************************************************* - -Grid physics library, www.github.com/paboyle/Grid - -Source file: ./lib/qcd/action/fermion/ImprovedStaggeredFermion.cc - -Copyright (C) 2015 - -Author: Azusa Yamaguchi, Peter Boyle - -This program is free software; you can redistribute it and/or modify -it under the terms of the GNU General Public License as published by -the Free Software Foundation; either version 2 of the License, or -(at your option) any later version. - -This program is distributed in the hope that it will be useful, -but WITHOUT ANY WARRANTY; without even the implied warranty of -MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the -GNU General Public License for more details. - -You should have received a copy of the GNU General Public License along -with this program; if not, write to the Free Software Foundation, Inc., -51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. - -See the full license in the file "LICENSE" in the top level distribution -directory -*************************************************************************************/ - /* END LEGAL */ -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class ImprovedStaggeredFermion; - -NAMESPACE_END(Grid); diff --git a/Grid/qcd/action/fermion/instantiation/StaggeredImplD/ImprovedStaggeredFermionInstantiationStaggeredImplD.cc b/Grid/qcd/action/fermion/instantiation/StaggeredImplD/ImprovedStaggeredFermionInstantiationStaggeredImplD.cc new file mode 120000 index 00000000..e239b39a --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/StaggeredImplD/ImprovedStaggeredFermionInstantiationStaggeredImplD.cc @@ -0,0 +1 @@ +../ImprovedStaggeredFermionInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/StaggeredImplD/StaggeredKernelsInstantiationStaggeredImplD.cc b/Grid/qcd/action/fermion/instantiation/StaggeredImplD/StaggeredKernelsInstantiationStaggeredImplD.cc deleted file mode 100644 index c3acf963..00000000 --- a/Grid/qcd/action/fermion/instantiation/StaggeredImplD/StaggeredKernelsInstantiationStaggeredImplD.cc +++ /dev/null @@ -1,39 +0,0 @@ -/************************************************************************************* - -Grid physics library, www.github.com/paboyle/Grid - -Source file: ./lib/qcd/action/fermion/WilsonKernels.cc - -Copyright (C) 2015 - -Author: Azusa Yamaguchi, Peter Boyle - -This program is free software; you can redistribute it and/or modify -it under the terms of the GNU General Public License as published by -the Free Software Foundation; either version 2 of the License, or -(at your option) any later version. - -This program is distributed in the hope that it will be useful, -but WITHOUT ANY WARRANTY; without even the implied warranty of -MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the -GNU General Public License for more details. - -You should have received a copy of the GNU General Public License along -with this program; if not, write to the Free Software Foundation, Inc., -51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. - -See the full license in the file "LICENSE" in the top level distribution -directory -*************************************************************************************/ -/* END LEGAL */ -#include -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class StaggeredKernels; - -NAMESPACE_END(Grid); - diff --git a/Grid/qcd/action/fermion/instantiation/StaggeredImplD/StaggeredKernelsInstantiationStaggeredImplD.cc b/Grid/qcd/action/fermion/instantiation/StaggeredImplD/StaggeredKernelsInstantiationStaggeredImplD.cc new file mode 120000 index 00000000..a4d1cbc9 --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/StaggeredImplD/StaggeredKernelsInstantiationStaggeredImplD.cc @@ -0,0 +1 @@ +../StaggeredKernelsInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/StaggeredImplF/ImprovedStaggeredFermion5DInstantiationStaggeredImplF.cc b/Grid/qcd/action/fermion/instantiation/StaggeredImplF/ImprovedStaggeredFermion5DInstantiationStaggeredImplF.cc deleted file mode 100644 index 572b375c..00000000 --- a/Grid/qcd/action/fermion/instantiation/StaggeredImplF/ImprovedStaggeredFermion5DInstantiationStaggeredImplF.cc +++ /dev/null @@ -1,44 +0,0 @@ -/************************************************************************************* - - Grid physics library, www.github.com/paboyle/Grid - - Source file: ./lib/qcd/action/fermion/ImprovedStaggeredFermion5D.cc - - Copyright (C) 2015 - -Author: Azusa Yamaguchi -Author: Peter Boyle - - This program is free software; you can redistribute it and/or modify - it under the terms of the GNU General Public License as published by - 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 - -#include -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class ImprovedStaggeredFermion5D; - -NAMESPACE_END(Grid); - - - - diff --git a/Grid/qcd/action/fermion/instantiation/StaggeredImplF/ImprovedStaggeredFermion5DInstantiationStaggeredImplF.cc b/Grid/qcd/action/fermion/instantiation/StaggeredImplF/ImprovedStaggeredFermion5DInstantiationStaggeredImplF.cc new file mode 120000 index 00000000..a8082840 --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/StaggeredImplF/ImprovedStaggeredFermion5DInstantiationStaggeredImplF.cc @@ -0,0 +1 @@ +../ImprovedStaggeredFermion5DInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/StaggeredImplF/ImprovedStaggeredFermionInstantiationStaggeredImplF.cc b/Grid/qcd/action/fermion/instantiation/StaggeredImplF/ImprovedStaggeredFermionInstantiationStaggeredImplF.cc deleted file mode 100644 index d35b7349..00000000 --- a/Grid/qcd/action/fermion/instantiation/StaggeredImplF/ImprovedStaggeredFermionInstantiationStaggeredImplF.cc +++ /dev/null @@ -1,37 +0,0 @@ -/************************************************************************************* - -Grid physics library, www.github.com/paboyle/Grid - -Source file: ./lib/qcd/action/fermion/ImprovedStaggeredFermion.cc - -Copyright (C) 2015 - -Author: Azusa Yamaguchi, Peter Boyle - -This program is free software; you can redistribute it and/or modify -it under the terms of the GNU General Public License as published by -the Free Software Foundation; either version 2 of the License, or -(at your option) any later version. - -This program is distributed in the hope that it will be useful, -but WITHOUT ANY WARRANTY; without even the implied warranty of -MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the -GNU General Public License for more details. - -You should have received a copy of the GNU General Public License along -with this program; if not, write to the Free Software Foundation, Inc., -51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. - -See the full license in the file "LICENSE" in the top level distribution -directory -*************************************************************************************/ - /* END LEGAL */ -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class ImprovedStaggeredFermion; - -NAMESPACE_END(Grid); diff --git a/Grid/qcd/action/fermion/instantiation/StaggeredImplF/ImprovedStaggeredFermionInstantiationStaggeredImplF.cc b/Grid/qcd/action/fermion/instantiation/StaggeredImplF/ImprovedStaggeredFermionInstantiationStaggeredImplF.cc new file mode 120000 index 00000000..e239b39a --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/StaggeredImplF/ImprovedStaggeredFermionInstantiationStaggeredImplF.cc @@ -0,0 +1 @@ +../ImprovedStaggeredFermionInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/StaggeredImplF/StaggeredKernelsInstantiationStaggeredImplF.cc b/Grid/qcd/action/fermion/instantiation/StaggeredImplF/StaggeredKernelsInstantiationStaggeredImplF.cc deleted file mode 100644 index c3acf963..00000000 --- a/Grid/qcd/action/fermion/instantiation/StaggeredImplF/StaggeredKernelsInstantiationStaggeredImplF.cc +++ /dev/null @@ -1,39 +0,0 @@ -/************************************************************************************* - -Grid physics library, www.github.com/paboyle/Grid - -Source file: ./lib/qcd/action/fermion/WilsonKernels.cc - -Copyright (C) 2015 - -Author: Azusa Yamaguchi, Peter Boyle - -This program is free software; you can redistribute it and/or modify -it under the terms of the GNU General Public License as published by -the Free Software Foundation; either version 2 of the License, or -(at your option) any later version. - -This program is distributed in the hope that it will be useful, -but WITHOUT ANY WARRANTY; without even the implied warranty of -MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the -GNU General Public License for more details. - -You should have received a copy of the GNU General Public License along -with this program; if not, write to the Free Software Foundation, Inc., -51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. - -See the full license in the file "LICENSE" in the top level distribution -directory -*************************************************************************************/ -/* END LEGAL */ -#include -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class StaggeredKernels; - -NAMESPACE_END(Grid); - diff --git a/Grid/qcd/action/fermion/instantiation/StaggeredImplF/StaggeredKernelsInstantiationStaggeredImplF.cc b/Grid/qcd/action/fermion/instantiation/StaggeredImplF/StaggeredKernelsInstantiationStaggeredImplF.cc new file mode 120000 index 00000000..a4d1cbc9 --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/StaggeredImplF/StaggeredKernelsInstantiationStaggeredImplF.cc @@ -0,0 +1 @@ +../StaggeredKernelsInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/WilsonAdjImplD/WilsonCloverFermionInstantiationWilsonAdjImplD.cc b/Grid/qcd/action/fermion/instantiation/WilsonAdjImplD/WilsonCloverFermionInstantiationWilsonAdjImplD.cc deleted file mode 100644 index af99dfb6..00000000 --- a/Grid/qcd/action/fermion/instantiation/WilsonAdjImplD/WilsonCloverFermionInstantiationWilsonAdjImplD.cc +++ /dev/null @@ -1,40 +0,0 @@ -/************************************************************************************* - - Grid physics library, www.github.com/paboyle/Grid - - Source file: ./lib/qcd/action/fermion/WilsonCloverFermion.cc - - Copyright (C) 2017 - - Author: paboyle - Author: Guido Cossu - - 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 -#include -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class WilsonCloverFermion; - -NAMESPACE_END(Grid); diff --git a/Grid/qcd/action/fermion/instantiation/WilsonAdjImplD/WilsonCloverFermionInstantiationWilsonAdjImplD.cc b/Grid/qcd/action/fermion/instantiation/WilsonAdjImplD/WilsonCloverFermionInstantiationWilsonAdjImplD.cc new file mode 120000 index 00000000..9cc05107 --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/WilsonAdjImplD/WilsonCloverFermionInstantiationWilsonAdjImplD.cc @@ -0,0 +1 @@ +../WilsonCloverFermionInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/WilsonAdjImplD/WilsonFermionInstantiationWilsonAdjImplD.cc b/Grid/qcd/action/fermion/instantiation/WilsonAdjImplD/WilsonFermionInstantiationWilsonAdjImplD.cc deleted file mode 100644 index 6fd9c5ca..00000000 --- a/Grid/qcd/action/fermion/instantiation/WilsonAdjImplD/WilsonFermionInstantiationWilsonAdjImplD.cc +++ /dev/null @@ -1,40 +0,0 @@ -/************************************************************************************* - -Grid physics library, www.github.com/paboyle/Grid - -Source file: ./lib/qcd/action/fermion/WilsonKernels.cc - -Copyright (C) 2015 - -Author: Peter Boyle -Author: Peter Boyle -Author: paboyle - -This program is free software; you can redistribute it and/or modify -it under the terms of the GNU General Public License as published by -the Free Software Foundation; either version 2 of the License, or -(at your option) any later version. - -This program is distributed in the hope that it will be useful, -but WITHOUT ANY WARRANTY; without even the implied warranty of -MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the -GNU General Public License for more details. - -You should have received a copy of the GNU General Public License along -with this program; if not, write to the Free Software Foundation, Inc., -51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. - -See the full license in the file "LICENSE" in the top level distribution -directory -*************************************************************************************/ -/* END LEGAL */ -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class WilsonFermion; - -NAMESPACE_END(Grid); - diff --git a/Grid/qcd/action/fermion/instantiation/WilsonAdjImplD/WilsonFermionInstantiationWilsonAdjImplD.cc b/Grid/qcd/action/fermion/instantiation/WilsonAdjImplD/WilsonFermionInstantiationWilsonAdjImplD.cc new file mode 120000 index 00000000..5f6ab65e --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/WilsonAdjImplD/WilsonFermionInstantiationWilsonAdjImplD.cc @@ -0,0 +1 @@ +../WilsonFermionInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/WilsonAdjImplD/WilsonKernelsInstantiationWilsonAdjImplD.cc b/Grid/qcd/action/fermion/instantiation/WilsonAdjImplD/WilsonKernelsInstantiationWilsonAdjImplD.cc deleted file mode 100644 index 9af5ed85..00000000 --- a/Grid/qcd/action/fermion/instantiation/WilsonAdjImplD/WilsonKernelsInstantiationWilsonAdjImplD.cc +++ /dev/null @@ -1,47 +0,0 @@ -/************************************************************************************* - -Grid physics library, www.github.com/paboyle/Grid - -Source file: ./lib/qcd/action/fermion/WilsonKernels.cc - -Copyright (C) 2015 - -Author: Peter Boyle -Author: Peter Boyle -Author: paboyle - -This program is free software; you can redistribute it and/or modify -it under the terms of the GNU General Public License as published by -the Free Software Foundation; either version 2 of the License, or -(at your option) any later version. - -This program is distributed in the hope that it will be useful, -but WITHOUT ANY WARRANTY; without even the implied warranty of -MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the -GNU General Public License for more details. - -You should have received a copy of the GNU General Public License along -with this program; if not, write to the Free Software Foundation, Inc., -51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. - -See the full license in the file "LICENSE" in the top level distribution -directory -*************************************************************************************/ -/* END LEGAL */ -#include -#include -#include - -#ifndef AVX512 -#ifndef QPX -#include -#endif -#endif - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class WilsonKernels; - -NAMESPACE_END(Grid); - diff --git a/Grid/qcd/action/fermion/instantiation/WilsonAdjImplD/WilsonKernelsInstantiationWilsonAdjImplD.cc b/Grid/qcd/action/fermion/instantiation/WilsonAdjImplD/WilsonKernelsInstantiationWilsonAdjImplD.cc new file mode 120000 index 00000000..01c35e7b --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/WilsonAdjImplD/WilsonKernelsInstantiationWilsonAdjImplD.cc @@ -0,0 +1 @@ +../WilsonKernelsInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/WilsonAdjImplD/WilsonTMFermionInstantiationWilsonAdjImplD.cc b/Grid/qcd/action/fermion/instantiation/WilsonAdjImplD/WilsonTMFermionInstantiationWilsonAdjImplD.cc deleted file mode 100644 index adfa310c..00000000 --- a/Grid/qcd/action/fermion/instantiation/WilsonAdjImplD/WilsonTMFermionInstantiationWilsonAdjImplD.cc +++ /dev/null @@ -1,37 +0,0 @@ -/************************************************************************************* - - Grid physics library, www.github.com/paboyle/Grid - - Source file: ./lib/qcd/action/fermion/WilsonTMFermion.cc - - Copyright (C) 2015 - -Author: paboyle - - This program is free software; you can redistribute it and/or modify - it under the terms of the GNU General Public License as published by - the Free Software Foundation; either version 2 of the License, or - (at your option) any later version. - - This program is 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 -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class WilsonTMFermion; - -NAMESPACE_END(Grid); diff --git a/Grid/qcd/action/fermion/instantiation/WilsonAdjImplD/WilsonTMFermionInstantiationWilsonAdjImplD.cc b/Grid/qcd/action/fermion/instantiation/WilsonAdjImplD/WilsonTMFermionInstantiationWilsonAdjImplD.cc new file mode 120000 index 00000000..d5789bcf --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/WilsonAdjImplD/WilsonTMFermionInstantiationWilsonAdjImplD.cc @@ -0,0 +1 @@ +../WilsonTMFermionInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/WilsonAdjImplF/WilsonCloverFermionInstantiationWilsonAdjImplF.cc b/Grid/qcd/action/fermion/instantiation/WilsonAdjImplF/WilsonCloverFermionInstantiationWilsonAdjImplF.cc deleted file mode 100644 index af99dfb6..00000000 --- a/Grid/qcd/action/fermion/instantiation/WilsonAdjImplF/WilsonCloverFermionInstantiationWilsonAdjImplF.cc +++ /dev/null @@ -1,40 +0,0 @@ -/************************************************************************************* - - Grid physics library, www.github.com/paboyle/Grid - - Source file: ./lib/qcd/action/fermion/WilsonCloverFermion.cc - - Copyright (C) 2017 - - Author: paboyle - Author: Guido Cossu - - 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 -#include -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class WilsonCloverFermion; - -NAMESPACE_END(Grid); diff --git a/Grid/qcd/action/fermion/instantiation/WilsonAdjImplF/WilsonCloverFermionInstantiationWilsonAdjImplF.cc b/Grid/qcd/action/fermion/instantiation/WilsonAdjImplF/WilsonCloverFermionInstantiationWilsonAdjImplF.cc new file mode 120000 index 00000000..9cc05107 --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/WilsonAdjImplF/WilsonCloverFermionInstantiationWilsonAdjImplF.cc @@ -0,0 +1 @@ +../WilsonCloverFermionInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/WilsonAdjImplF/WilsonFermionInstantiationWilsonAdjImplF.cc b/Grid/qcd/action/fermion/instantiation/WilsonAdjImplF/WilsonFermionInstantiationWilsonAdjImplF.cc deleted file mode 100644 index 6fd9c5ca..00000000 --- a/Grid/qcd/action/fermion/instantiation/WilsonAdjImplF/WilsonFermionInstantiationWilsonAdjImplF.cc +++ /dev/null @@ -1,40 +0,0 @@ -/************************************************************************************* - -Grid physics library, www.github.com/paboyle/Grid - -Source file: ./lib/qcd/action/fermion/WilsonKernels.cc - -Copyright (C) 2015 - -Author: Peter Boyle -Author: Peter Boyle -Author: paboyle - -This program is free software; you can redistribute it and/or modify -it under the terms of the GNU General Public License as published by -the Free Software Foundation; either version 2 of the License, or -(at your option) any later version. - -This program is distributed in the hope that it will be useful, -but WITHOUT ANY WARRANTY; without even the implied warranty of -MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the -GNU General Public License for more details. - -You should have received a copy of the GNU General Public License along -with this program; if not, write to the Free Software Foundation, Inc., -51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. - -See the full license in the file "LICENSE" in the top level distribution -directory -*************************************************************************************/ -/* END LEGAL */ -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class WilsonFermion; - -NAMESPACE_END(Grid); - diff --git a/Grid/qcd/action/fermion/instantiation/WilsonAdjImplF/WilsonFermionInstantiationWilsonAdjImplF.cc b/Grid/qcd/action/fermion/instantiation/WilsonAdjImplF/WilsonFermionInstantiationWilsonAdjImplF.cc new file mode 120000 index 00000000..5f6ab65e --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/WilsonAdjImplF/WilsonFermionInstantiationWilsonAdjImplF.cc @@ -0,0 +1 @@ +../WilsonFermionInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/WilsonAdjImplF/WilsonKernelsInstantiationWilsonAdjImplF.cc b/Grid/qcd/action/fermion/instantiation/WilsonAdjImplF/WilsonKernelsInstantiationWilsonAdjImplF.cc deleted file mode 100644 index 9af5ed85..00000000 --- a/Grid/qcd/action/fermion/instantiation/WilsonAdjImplF/WilsonKernelsInstantiationWilsonAdjImplF.cc +++ /dev/null @@ -1,47 +0,0 @@ -/************************************************************************************* - -Grid physics library, www.github.com/paboyle/Grid - -Source file: ./lib/qcd/action/fermion/WilsonKernels.cc - -Copyright (C) 2015 - -Author: Peter Boyle -Author: Peter Boyle -Author: paboyle - -This program is free software; you can redistribute it and/or modify -it under the terms of the GNU General Public License as published by -the Free Software Foundation; either version 2 of the License, or -(at your option) any later version. - -This program is distributed in the hope that it will be useful, -but WITHOUT ANY WARRANTY; without even the implied warranty of -MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the -GNU General Public License for more details. - -You should have received a copy of the GNU General Public License along -with this program; if not, write to the Free Software Foundation, Inc., -51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. - -See the full license in the file "LICENSE" in the top level distribution -directory -*************************************************************************************/ -/* END LEGAL */ -#include -#include -#include - -#ifndef AVX512 -#ifndef QPX -#include -#endif -#endif - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class WilsonKernels; - -NAMESPACE_END(Grid); - diff --git a/Grid/qcd/action/fermion/instantiation/WilsonAdjImplF/WilsonKernelsInstantiationWilsonAdjImplF.cc b/Grid/qcd/action/fermion/instantiation/WilsonAdjImplF/WilsonKernelsInstantiationWilsonAdjImplF.cc new file mode 120000 index 00000000..01c35e7b --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/WilsonAdjImplF/WilsonKernelsInstantiationWilsonAdjImplF.cc @@ -0,0 +1 @@ +../WilsonKernelsInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/WilsonAdjImplF/WilsonTMFermionInstantiationWilsonAdjImplF.cc b/Grid/qcd/action/fermion/instantiation/WilsonAdjImplF/WilsonTMFermionInstantiationWilsonAdjImplF.cc deleted file mode 100644 index adfa310c..00000000 --- a/Grid/qcd/action/fermion/instantiation/WilsonAdjImplF/WilsonTMFermionInstantiationWilsonAdjImplF.cc +++ /dev/null @@ -1,37 +0,0 @@ -/************************************************************************************* - - Grid physics library, www.github.com/paboyle/Grid - - Source file: ./lib/qcd/action/fermion/WilsonTMFermion.cc - - Copyright (C) 2015 - -Author: paboyle - - This program is free software; you can redistribute it and/or modify - it under the terms of the GNU General Public License as published by - the Free Software Foundation; either version 2 of the License, or - (at your option) any later version. - - This program is 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 -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class WilsonTMFermion; - -NAMESPACE_END(Grid); diff --git a/Grid/qcd/action/fermion/instantiation/WilsonAdjImplF/WilsonTMFermionInstantiationWilsonAdjImplF.cc b/Grid/qcd/action/fermion/instantiation/WilsonAdjImplF/WilsonTMFermionInstantiationWilsonAdjImplF.cc new file mode 120000 index 00000000..d5789bcf --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/WilsonAdjImplF/WilsonTMFermionInstantiationWilsonAdjImplF.cc @@ -0,0 +1 @@ +../WilsonTMFermionInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/WilsonImplD/CayleyFermion5DInstantiationWilsonImplD.cc b/Grid/qcd/action/fermion/instantiation/WilsonImplD/CayleyFermion5DInstantiationWilsonImplD.cc deleted file mode 100644 index 5130db9c..00000000 --- a/Grid/qcd/action/fermion/instantiation/WilsonImplD/CayleyFermion5DInstantiationWilsonImplD.cc +++ /dev/null @@ -1,44 +0,0 @@ -/************************************************************************************* - -Grid physics library, www.github.com/paboyle/Grid - -Source file: ./lib/qcd/action/fermion/WilsonKernels.cc - -Copyright (C) 2015 - -Author: Peter Boyle -Author: Peter Boyle -Author: paboyle - -This program is free software; you can redistribute it and/or modify -it under the terms of the GNU General Public License as published by -the Free Software Foundation; either version 2 of the License, or -(at your option) any later version. - -This program is distributed in the hope that it will be useful, -but WITHOUT ANY WARRANTY; without even the implied warranty of -MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the -GNU General Public License for more details. - -You should have received a copy of the GNU General Public License along -with this program; if not, write to the Free Software Foundation, Inc., -51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. - -See the full license in the file "LICENSE" in the top level distribution -directory -*************************************************************************************/ -/* END LEGAL */ -#include -#include -#include - - //#include - //#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class CayleyFermion5D; - -NAMESPACE_END(Grid); - diff --git a/Grid/qcd/action/fermion/instantiation/WilsonImplD/CayleyFermion5DInstantiationWilsonImplD.cc b/Grid/qcd/action/fermion/instantiation/WilsonImplD/CayleyFermion5DInstantiationWilsonImplD.cc new file mode 120000 index 00000000..cb1db625 --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/WilsonImplD/CayleyFermion5DInstantiationWilsonImplD.cc @@ -0,0 +1 @@ +../CayleyFermion5DInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/WilsonImplD/ContinuedFractionFermion5DInstantiationWilsonImplD.cc b/Grid/qcd/action/fermion/instantiation/WilsonImplD/ContinuedFractionFermion5DInstantiationWilsonImplD.cc deleted file mode 100644 index ca0d6cea..00000000 --- a/Grid/qcd/action/fermion/instantiation/WilsonImplD/ContinuedFractionFermion5DInstantiationWilsonImplD.cc +++ /dev/null @@ -1,38 +0,0 @@ -/************************************************************************************* - - Grid physics library, www.github.com/paboyle/Grid - - Source file: ./lib/qcd/action/fermion/ContinuedFractionFermion5D.cc - - Copyright (C) 2015 - -Author: Peter Boyle -Author: Peter Boyle - - This program is free software; you can redistribute it and/or modify - it under the terms of the GNU General Public License as published by - the Free Software Foundation; either version 2 of the License, or - (at your option) any later version. - - This program is distributed in the hope that it will be useful, - but WITHOUT ANY WARRANTY; without even the implied warranty of - MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the - GNU General Public License for more details. - - You should have received a copy of the GNU General Public License along - with this program; if not, write to the Free Software Foundation, Inc., - 51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. - - See the full license in the file "LICENSE" in the top level distribution directory -*************************************************************************************/ -/* END LEGAL */ -#include -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class ContinuedFractionFermion5D; - -NAMESPACE_END(Grid); diff --git a/Grid/qcd/action/fermion/instantiation/WilsonImplD/ContinuedFractionFermion5DInstantiationWilsonImplD.cc b/Grid/qcd/action/fermion/instantiation/WilsonImplD/ContinuedFractionFermion5DInstantiationWilsonImplD.cc new file mode 120000 index 00000000..c2d4b8fc --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/WilsonImplD/ContinuedFractionFermion5DInstantiationWilsonImplD.cc @@ -0,0 +1 @@ +../ContinuedFractionFermion5DInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/WilsonImplD/DomainWallEOFAFermionInstantiationWilsonImplD.cc b/Grid/qcd/action/fermion/instantiation/WilsonImplD/DomainWallEOFAFermionInstantiationWilsonImplD.cc deleted file mode 100644 index f7198131..00000000 --- a/Grid/qcd/action/fermion/instantiation/WilsonImplD/DomainWallEOFAFermionInstantiationWilsonImplD.cc +++ /dev/null @@ -1,44 +0,0 @@ -/************************************************************************************* - -Grid physics library, www.github.com/paboyle/Grid - -Source file: ./lib/qcd/action/fermion/DomainWallEOFAFermion.cc - -Copyright (C) 2017 - -Author: Peter Boyle -Author: Peter Boyle -Author: Peter Boyle -Author: paboyle -Author: David Murphy - -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 -#include -#include -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class DomainWallEOFAFermion; - -NAMESPACE_END(Grid); diff --git a/Grid/qcd/action/fermion/instantiation/WilsonImplD/DomainWallEOFAFermionInstantiationWilsonImplD.cc b/Grid/qcd/action/fermion/instantiation/WilsonImplD/DomainWallEOFAFermionInstantiationWilsonImplD.cc new file mode 120000 index 00000000..2f550a2b --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/WilsonImplD/DomainWallEOFAFermionInstantiationWilsonImplD.cc @@ -0,0 +1 @@ +../DomainWallEOFAFermionInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/WilsonImplD/MobiusEOFAFermionInstantiationWilsonImplD.cc b/Grid/qcd/action/fermion/instantiation/WilsonImplD/MobiusEOFAFermionInstantiationWilsonImplD.cc deleted file mode 100644 index ce7eaac9..00000000 --- a/Grid/qcd/action/fermion/instantiation/WilsonImplD/MobiusEOFAFermionInstantiationWilsonImplD.cc +++ /dev/null @@ -1,44 +0,0 @@ -/************************************************************************************* - -Grid physics library, www.github.com/paboyle/Grid - -Source file: ./lib/qcd/action/fermion/MobiusEOFAFermion.cc - -Copyright (C) 2017 - -Author: Peter Boyle -Author: Peter Boyle -Author: Peter Boyle -Author: paboyle -Author: David Murphy - -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 -#include -#include -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class MobiusEOFAFermion; - -NAMESPACE_END(Grid); diff --git a/Grid/qcd/action/fermion/instantiation/WilsonImplD/MobiusEOFAFermionInstantiationWilsonImplD.cc b/Grid/qcd/action/fermion/instantiation/WilsonImplD/MobiusEOFAFermionInstantiationWilsonImplD.cc new file mode 120000 index 00000000..7a8f1172 --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/WilsonImplD/MobiusEOFAFermionInstantiationWilsonImplD.cc @@ -0,0 +1 @@ +../MobiusEOFAFermionInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/WilsonImplD/PartialFractionFermion5DInstantiationWilsonImplD.cc b/Grid/qcd/action/fermion/instantiation/WilsonImplD/PartialFractionFermion5DInstantiationWilsonImplD.cc deleted file mode 100644 index 757719b6..00000000 --- a/Grid/qcd/action/fermion/instantiation/WilsonImplD/PartialFractionFermion5DInstantiationWilsonImplD.cc +++ /dev/null @@ -1,39 +0,0 @@ -/************************************************************************************* - - Grid physics library, www.github.com/paboyle/Grid - - Source file: ./lib/qcd/action/fermion/PartialFractionFermion5D.cc - - Copyright (C) 2015 - -Author: Peter Boyle -Author: Peter Boyle - - This program is free software; you can redistribute it and/or modify - it under the terms of the GNU General Public License as published by - the Free Software Foundation; either version 2 of the License, or - (at your option) any later version. - - This program is distributed in the hope that it will be useful, - but WITHOUT ANY WARRANTY; without even the implied warranty of - MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the - GNU General Public License for more details. - - You should have received a copy of the GNU General Public License along - with this program; if not, write to the Free Software Foundation, Inc., - 51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. - - See the full license in the file "LICENSE" in the top level distribution directory -*************************************************************************************/ -/* END LEGAL */ -#include -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class PartialFractionFermion5D; - -NAMESPACE_END(Grid); - diff --git a/Grid/qcd/action/fermion/instantiation/WilsonImplD/PartialFractionFermion5DInstantiationWilsonImplD.cc b/Grid/qcd/action/fermion/instantiation/WilsonImplD/PartialFractionFermion5DInstantiationWilsonImplD.cc new file mode 120000 index 00000000..7f4cea71 --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/WilsonImplD/PartialFractionFermion5DInstantiationWilsonImplD.cc @@ -0,0 +1 @@ +../PartialFractionFermion5DInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/WilsonImplD/WilsonCloverFermionInstantiationWilsonImplD.cc b/Grid/qcd/action/fermion/instantiation/WilsonImplD/WilsonCloverFermionInstantiationWilsonImplD.cc deleted file mode 100644 index af99dfb6..00000000 --- a/Grid/qcd/action/fermion/instantiation/WilsonImplD/WilsonCloverFermionInstantiationWilsonImplD.cc +++ /dev/null @@ -1,40 +0,0 @@ -/************************************************************************************* - - Grid physics library, www.github.com/paboyle/Grid - - Source file: ./lib/qcd/action/fermion/WilsonCloverFermion.cc - - Copyright (C) 2017 - - Author: paboyle - Author: Guido Cossu - - 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 -#include -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class WilsonCloverFermion; - -NAMESPACE_END(Grid); diff --git a/Grid/qcd/action/fermion/instantiation/WilsonImplD/WilsonCloverFermionInstantiationWilsonImplD.cc b/Grid/qcd/action/fermion/instantiation/WilsonImplD/WilsonCloverFermionInstantiationWilsonImplD.cc new file mode 120000 index 00000000..9cc05107 --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/WilsonImplD/WilsonCloverFermionInstantiationWilsonImplD.cc @@ -0,0 +1 @@ +../WilsonCloverFermionInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/WilsonImplD/WilsonFermion5DInstantiationWilsonImplD.cc b/Grid/qcd/action/fermion/instantiation/WilsonImplD/WilsonFermion5DInstantiationWilsonImplD.cc deleted file mode 100644 index 0dac989c..00000000 --- a/Grid/qcd/action/fermion/instantiation/WilsonImplD/WilsonFermion5DInstantiationWilsonImplD.cc +++ /dev/null @@ -1,40 +0,0 @@ -/************************************************************************************* - -Grid physics library, www.github.com/paboyle/Grid - -Source file: ./lib/qcd/action/fermion/WilsonKernels.cc - -Copyright (C) 2015 - -Author: Peter Boyle -Author: Peter Boyle -Author: paboyle - -This program is free software; you can redistribute it and/or modify -it under the terms of the GNU General Public License as published by -the Free Software Foundation; either version 2 of the License, or -(at your option) any later version. - -This program is distributed in the hope that it will be useful, -but WITHOUT ANY WARRANTY; without even the implied warranty of -MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the -GNU General Public License for more details. - -You should have received a copy of the GNU General Public License along -with this program; if not, write to the Free Software Foundation, Inc., -51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. - -See the full license in the file "LICENSE" in the top level distribution -directory -*************************************************************************************/ -/* END LEGAL */ -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class WilsonFermion5D; - -NAMESPACE_END(Grid); - diff --git a/Grid/qcd/action/fermion/instantiation/WilsonImplD/WilsonFermion5DInstantiationWilsonImplD.cc b/Grid/qcd/action/fermion/instantiation/WilsonImplD/WilsonFermion5DInstantiationWilsonImplD.cc new file mode 120000 index 00000000..804d0884 --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/WilsonImplD/WilsonFermion5DInstantiationWilsonImplD.cc @@ -0,0 +1 @@ +../WilsonFermion5DInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/WilsonImplD/WilsonFermionInstantiationWilsonImplD.cc b/Grid/qcd/action/fermion/instantiation/WilsonImplD/WilsonFermionInstantiationWilsonImplD.cc deleted file mode 100644 index 6fd9c5ca..00000000 --- a/Grid/qcd/action/fermion/instantiation/WilsonImplD/WilsonFermionInstantiationWilsonImplD.cc +++ /dev/null @@ -1,40 +0,0 @@ -/************************************************************************************* - -Grid physics library, www.github.com/paboyle/Grid - -Source file: ./lib/qcd/action/fermion/WilsonKernels.cc - -Copyright (C) 2015 - -Author: Peter Boyle -Author: Peter Boyle -Author: paboyle - -This program is free software; you can redistribute it and/or modify -it under the terms of the GNU General Public License as published by -the Free Software Foundation; either version 2 of the License, or -(at your option) any later version. - -This program is distributed in the hope that it will be useful, -but WITHOUT ANY WARRANTY; without even the implied warranty of -MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the -GNU General Public License for more details. - -You should have received a copy of the GNU General Public License along -with this program; if not, write to the Free Software Foundation, Inc., -51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. - -See the full license in the file "LICENSE" in the top level distribution -directory -*************************************************************************************/ -/* END LEGAL */ -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class WilsonFermion; - -NAMESPACE_END(Grid); - diff --git a/Grid/qcd/action/fermion/instantiation/WilsonImplD/WilsonFermionInstantiationWilsonImplD.cc b/Grid/qcd/action/fermion/instantiation/WilsonImplD/WilsonFermionInstantiationWilsonImplD.cc new file mode 120000 index 00000000..5f6ab65e --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/WilsonImplD/WilsonFermionInstantiationWilsonImplD.cc @@ -0,0 +1 @@ +../WilsonFermionInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/WilsonImplD/WilsonKernelsInstantiationWilsonImplD.cc b/Grid/qcd/action/fermion/instantiation/WilsonImplD/WilsonKernelsInstantiationWilsonImplD.cc deleted file mode 100644 index 9af5ed85..00000000 --- a/Grid/qcd/action/fermion/instantiation/WilsonImplD/WilsonKernelsInstantiationWilsonImplD.cc +++ /dev/null @@ -1,47 +0,0 @@ -/************************************************************************************* - -Grid physics library, www.github.com/paboyle/Grid - -Source file: ./lib/qcd/action/fermion/WilsonKernels.cc - -Copyright (C) 2015 - -Author: Peter Boyle -Author: Peter Boyle -Author: paboyle - -This program is free software; you can redistribute it and/or modify -it under the terms of the GNU General Public License as published by -the Free Software Foundation; either version 2 of the License, or -(at your option) any later version. - -This program is distributed in the hope that it will be useful, -but WITHOUT ANY WARRANTY; without even the implied warranty of -MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the -GNU General Public License for more details. - -You should have received a copy of the GNU General Public License along -with this program; if not, write to the Free Software Foundation, Inc., -51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. - -See the full license in the file "LICENSE" in the top level distribution -directory -*************************************************************************************/ -/* END LEGAL */ -#include -#include -#include - -#ifndef AVX512 -#ifndef QPX -#include -#endif -#endif - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class WilsonKernels; - -NAMESPACE_END(Grid); - diff --git a/Grid/qcd/action/fermion/instantiation/WilsonImplD/WilsonKernelsInstantiationWilsonImplD.cc b/Grid/qcd/action/fermion/instantiation/WilsonImplD/WilsonKernelsInstantiationWilsonImplD.cc new file mode 120000 index 00000000..01c35e7b --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/WilsonImplD/WilsonKernelsInstantiationWilsonImplD.cc @@ -0,0 +1 @@ +../WilsonKernelsInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/WilsonImplD/WilsonTMFermionInstantiationWilsonImplD.cc b/Grid/qcd/action/fermion/instantiation/WilsonImplD/WilsonTMFermionInstantiationWilsonImplD.cc deleted file mode 100644 index adfa310c..00000000 --- a/Grid/qcd/action/fermion/instantiation/WilsonImplD/WilsonTMFermionInstantiationWilsonImplD.cc +++ /dev/null @@ -1,37 +0,0 @@ -/************************************************************************************* - - Grid physics library, www.github.com/paboyle/Grid - - Source file: ./lib/qcd/action/fermion/WilsonTMFermion.cc - - Copyright (C) 2015 - -Author: paboyle - - This program is free software; you can redistribute it and/or modify - it under the terms of the GNU General Public License as published by - the Free Software Foundation; either version 2 of the License, or - (at your option) any later version. - - This program is 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 -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class WilsonTMFermion; - -NAMESPACE_END(Grid); diff --git a/Grid/qcd/action/fermion/instantiation/WilsonImplD/WilsonTMFermionInstantiationWilsonImplD.cc b/Grid/qcd/action/fermion/instantiation/WilsonImplD/WilsonTMFermionInstantiationWilsonImplD.cc new file mode 120000 index 00000000..d5789bcf --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/WilsonImplD/WilsonTMFermionInstantiationWilsonImplD.cc @@ -0,0 +1 @@ +../WilsonTMFermionInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/WilsonImplDF/CayleyFermion5DInstantiationWilsonImplDF.cc b/Grid/qcd/action/fermion/instantiation/WilsonImplDF/CayleyFermion5DInstantiationWilsonImplDF.cc deleted file mode 100644 index 5130db9c..00000000 --- a/Grid/qcd/action/fermion/instantiation/WilsonImplDF/CayleyFermion5DInstantiationWilsonImplDF.cc +++ /dev/null @@ -1,44 +0,0 @@ -/************************************************************************************* - -Grid physics library, www.github.com/paboyle/Grid - -Source file: ./lib/qcd/action/fermion/WilsonKernels.cc - -Copyright (C) 2015 - -Author: Peter Boyle -Author: Peter Boyle -Author: paboyle - -This program is free software; you can redistribute it and/or modify -it under the terms of the GNU General Public License as published by -the Free Software Foundation; either version 2 of the License, or -(at your option) any later version. - -This program is distributed in the hope that it will be useful, -but WITHOUT ANY WARRANTY; without even the implied warranty of -MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the -GNU General Public License for more details. - -You should have received a copy of the GNU General Public License along -with this program; if not, write to the Free Software Foundation, Inc., -51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. - -See the full license in the file "LICENSE" in the top level distribution -directory -*************************************************************************************/ -/* END LEGAL */ -#include -#include -#include - - //#include - //#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class CayleyFermion5D; - -NAMESPACE_END(Grid); - diff --git a/Grid/qcd/action/fermion/instantiation/WilsonImplDF/CayleyFermion5DInstantiationWilsonImplDF.cc b/Grid/qcd/action/fermion/instantiation/WilsonImplDF/CayleyFermion5DInstantiationWilsonImplDF.cc new file mode 120000 index 00000000..cb1db625 --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/WilsonImplDF/CayleyFermion5DInstantiationWilsonImplDF.cc @@ -0,0 +1 @@ +../CayleyFermion5DInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/WilsonImplDF/ContinuedFractionFermion5DInstantiationWilsonImplDF.cc b/Grid/qcd/action/fermion/instantiation/WilsonImplDF/ContinuedFractionFermion5DInstantiationWilsonImplDF.cc deleted file mode 100644 index ca0d6cea..00000000 --- a/Grid/qcd/action/fermion/instantiation/WilsonImplDF/ContinuedFractionFermion5DInstantiationWilsonImplDF.cc +++ /dev/null @@ -1,38 +0,0 @@ -/************************************************************************************* - - Grid physics library, www.github.com/paboyle/Grid - - Source file: ./lib/qcd/action/fermion/ContinuedFractionFermion5D.cc - - Copyright (C) 2015 - -Author: Peter Boyle -Author: Peter Boyle - - This program is free software; you can redistribute it and/or modify - it under the terms of the GNU General Public License as published by - the Free Software Foundation; either version 2 of the License, or - (at your option) any later version. - - This program is distributed in the hope that it will be useful, - but WITHOUT ANY WARRANTY; without even the implied warranty of - MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the - GNU General Public License for more details. - - You should have received a copy of the GNU General Public License along - with this program; if not, write to the Free Software Foundation, Inc., - 51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. - - See the full license in the file "LICENSE" in the top level distribution directory -*************************************************************************************/ -/* END LEGAL */ -#include -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class ContinuedFractionFermion5D; - -NAMESPACE_END(Grid); diff --git a/Grid/qcd/action/fermion/instantiation/WilsonImplDF/ContinuedFractionFermion5DInstantiationWilsonImplDF.cc b/Grid/qcd/action/fermion/instantiation/WilsonImplDF/ContinuedFractionFermion5DInstantiationWilsonImplDF.cc new file mode 120000 index 00000000..c2d4b8fc --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/WilsonImplDF/ContinuedFractionFermion5DInstantiationWilsonImplDF.cc @@ -0,0 +1 @@ +../ContinuedFractionFermion5DInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/WilsonImplDF/DomainWallEOFAFermionInstantiationWilsonImplDF.cc b/Grid/qcd/action/fermion/instantiation/WilsonImplDF/DomainWallEOFAFermionInstantiationWilsonImplDF.cc deleted file mode 100644 index f7198131..00000000 --- a/Grid/qcd/action/fermion/instantiation/WilsonImplDF/DomainWallEOFAFermionInstantiationWilsonImplDF.cc +++ /dev/null @@ -1,44 +0,0 @@ -/************************************************************************************* - -Grid physics library, www.github.com/paboyle/Grid - -Source file: ./lib/qcd/action/fermion/DomainWallEOFAFermion.cc - -Copyright (C) 2017 - -Author: Peter Boyle -Author: Peter Boyle -Author: Peter Boyle -Author: paboyle -Author: David Murphy - -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 -#include -#include -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class DomainWallEOFAFermion; - -NAMESPACE_END(Grid); diff --git a/Grid/qcd/action/fermion/instantiation/WilsonImplDF/DomainWallEOFAFermionInstantiationWilsonImplDF.cc b/Grid/qcd/action/fermion/instantiation/WilsonImplDF/DomainWallEOFAFermionInstantiationWilsonImplDF.cc new file mode 120000 index 00000000..2f550a2b --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/WilsonImplDF/DomainWallEOFAFermionInstantiationWilsonImplDF.cc @@ -0,0 +1 @@ +../DomainWallEOFAFermionInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/WilsonImplDF/MobiusEOFAFermionInstantiationWilsonImplDF.cc b/Grid/qcd/action/fermion/instantiation/WilsonImplDF/MobiusEOFAFermionInstantiationWilsonImplDF.cc deleted file mode 100644 index ce7eaac9..00000000 --- a/Grid/qcd/action/fermion/instantiation/WilsonImplDF/MobiusEOFAFermionInstantiationWilsonImplDF.cc +++ /dev/null @@ -1,44 +0,0 @@ -/************************************************************************************* - -Grid physics library, www.github.com/paboyle/Grid - -Source file: ./lib/qcd/action/fermion/MobiusEOFAFermion.cc - -Copyright (C) 2017 - -Author: Peter Boyle -Author: Peter Boyle -Author: Peter Boyle -Author: paboyle -Author: David Murphy - -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 -#include -#include -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class MobiusEOFAFermion; - -NAMESPACE_END(Grid); diff --git a/Grid/qcd/action/fermion/instantiation/WilsonImplDF/MobiusEOFAFermionInstantiationWilsonImplDF.cc b/Grid/qcd/action/fermion/instantiation/WilsonImplDF/MobiusEOFAFermionInstantiationWilsonImplDF.cc new file mode 120000 index 00000000..7a8f1172 --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/WilsonImplDF/MobiusEOFAFermionInstantiationWilsonImplDF.cc @@ -0,0 +1 @@ +../MobiusEOFAFermionInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/WilsonImplDF/PartialFractionFermion5DInstantiationWilsonImplDF.cc b/Grid/qcd/action/fermion/instantiation/WilsonImplDF/PartialFractionFermion5DInstantiationWilsonImplDF.cc deleted file mode 100644 index 757719b6..00000000 --- a/Grid/qcd/action/fermion/instantiation/WilsonImplDF/PartialFractionFermion5DInstantiationWilsonImplDF.cc +++ /dev/null @@ -1,39 +0,0 @@ -/************************************************************************************* - - Grid physics library, www.github.com/paboyle/Grid - - Source file: ./lib/qcd/action/fermion/PartialFractionFermion5D.cc - - Copyright (C) 2015 - -Author: Peter Boyle -Author: Peter Boyle - - This program is free software; you can redistribute it and/or modify - it under the terms of the GNU General Public License as published by - the Free Software Foundation; either version 2 of the License, or - (at your option) any later version. - - This program is distributed in the hope that it will be useful, - but WITHOUT ANY WARRANTY; without even the implied warranty of - MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the - GNU General Public License for more details. - - You should have received a copy of the GNU General Public License along - with this program; if not, write to the Free Software Foundation, Inc., - 51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. - - See the full license in the file "LICENSE" in the top level distribution directory -*************************************************************************************/ -/* END LEGAL */ -#include -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class PartialFractionFermion5D; - -NAMESPACE_END(Grid); - diff --git a/Grid/qcd/action/fermion/instantiation/WilsonImplDF/PartialFractionFermion5DInstantiationWilsonImplDF.cc b/Grid/qcd/action/fermion/instantiation/WilsonImplDF/PartialFractionFermion5DInstantiationWilsonImplDF.cc new file mode 120000 index 00000000..7f4cea71 --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/WilsonImplDF/PartialFractionFermion5DInstantiationWilsonImplDF.cc @@ -0,0 +1 @@ +../PartialFractionFermion5DInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/WilsonImplDF/WilsonCloverFermionInstantiationWilsonImplDF.cc b/Grid/qcd/action/fermion/instantiation/WilsonImplDF/WilsonCloverFermionInstantiationWilsonImplDF.cc deleted file mode 100644 index af99dfb6..00000000 --- a/Grid/qcd/action/fermion/instantiation/WilsonImplDF/WilsonCloverFermionInstantiationWilsonImplDF.cc +++ /dev/null @@ -1,40 +0,0 @@ -/************************************************************************************* - - Grid physics library, www.github.com/paboyle/Grid - - Source file: ./lib/qcd/action/fermion/WilsonCloverFermion.cc - - Copyright (C) 2017 - - Author: paboyle - Author: Guido Cossu - - 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 -#include -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class WilsonCloverFermion; - -NAMESPACE_END(Grid); diff --git a/Grid/qcd/action/fermion/instantiation/WilsonImplDF/WilsonCloverFermionInstantiationWilsonImplDF.cc b/Grid/qcd/action/fermion/instantiation/WilsonImplDF/WilsonCloverFermionInstantiationWilsonImplDF.cc new file mode 120000 index 00000000..9cc05107 --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/WilsonImplDF/WilsonCloverFermionInstantiationWilsonImplDF.cc @@ -0,0 +1 @@ +../WilsonCloverFermionInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/WilsonImplDF/WilsonFermion5DInstantiationWilsonImplDF.cc b/Grid/qcd/action/fermion/instantiation/WilsonImplDF/WilsonFermion5DInstantiationWilsonImplDF.cc deleted file mode 100644 index 0dac989c..00000000 --- a/Grid/qcd/action/fermion/instantiation/WilsonImplDF/WilsonFermion5DInstantiationWilsonImplDF.cc +++ /dev/null @@ -1,40 +0,0 @@ -/************************************************************************************* - -Grid physics library, www.github.com/paboyle/Grid - -Source file: ./lib/qcd/action/fermion/WilsonKernels.cc - -Copyright (C) 2015 - -Author: Peter Boyle -Author: Peter Boyle -Author: paboyle - -This program is free software; you can redistribute it and/or modify -it under the terms of the GNU General Public License as published by -the Free Software Foundation; either version 2 of the License, or -(at your option) any later version. - -This program is distributed in the hope that it will be useful, -but WITHOUT ANY WARRANTY; without even the implied warranty of -MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the -GNU General Public License for more details. - -You should have received a copy of the GNU General Public License along -with this program; if not, write to the Free Software Foundation, Inc., -51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. - -See the full license in the file "LICENSE" in the top level distribution -directory -*************************************************************************************/ -/* END LEGAL */ -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class WilsonFermion5D; - -NAMESPACE_END(Grid); - diff --git a/Grid/qcd/action/fermion/instantiation/WilsonImplDF/WilsonFermion5DInstantiationWilsonImplDF.cc b/Grid/qcd/action/fermion/instantiation/WilsonImplDF/WilsonFermion5DInstantiationWilsonImplDF.cc new file mode 120000 index 00000000..804d0884 --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/WilsonImplDF/WilsonFermion5DInstantiationWilsonImplDF.cc @@ -0,0 +1 @@ +../WilsonFermion5DInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/WilsonImplDF/WilsonFermionInstantiationWilsonImplDF.cc b/Grid/qcd/action/fermion/instantiation/WilsonImplDF/WilsonFermionInstantiationWilsonImplDF.cc deleted file mode 100644 index 6fd9c5ca..00000000 --- a/Grid/qcd/action/fermion/instantiation/WilsonImplDF/WilsonFermionInstantiationWilsonImplDF.cc +++ /dev/null @@ -1,40 +0,0 @@ -/************************************************************************************* - -Grid physics library, www.github.com/paboyle/Grid - -Source file: ./lib/qcd/action/fermion/WilsonKernels.cc - -Copyright (C) 2015 - -Author: Peter Boyle -Author: Peter Boyle -Author: paboyle - -This program is free software; you can redistribute it and/or modify -it under the terms of the GNU General Public License as published by -the Free Software Foundation; either version 2 of the License, or -(at your option) any later version. - -This program is distributed in the hope that it will be useful, -but WITHOUT ANY WARRANTY; without even the implied warranty of -MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the -GNU General Public License for more details. - -You should have received a copy of the GNU General Public License along -with this program; if not, write to the Free Software Foundation, Inc., -51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. - -See the full license in the file "LICENSE" in the top level distribution -directory -*************************************************************************************/ -/* END LEGAL */ -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class WilsonFermion; - -NAMESPACE_END(Grid); - diff --git a/Grid/qcd/action/fermion/instantiation/WilsonImplDF/WilsonFermionInstantiationWilsonImplDF.cc b/Grid/qcd/action/fermion/instantiation/WilsonImplDF/WilsonFermionInstantiationWilsonImplDF.cc new file mode 120000 index 00000000..5f6ab65e --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/WilsonImplDF/WilsonFermionInstantiationWilsonImplDF.cc @@ -0,0 +1 @@ +../WilsonFermionInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/WilsonImplDF/WilsonKernelsInstantiationWilsonImplDF.cc b/Grid/qcd/action/fermion/instantiation/WilsonImplDF/WilsonKernelsInstantiationWilsonImplDF.cc deleted file mode 100644 index 9af5ed85..00000000 --- a/Grid/qcd/action/fermion/instantiation/WilsonImplDF/WilsonKernelsInstantiationWilsonImplDF.cc +++ /dev/null @@ -1,47 +0,0 @@ -/************************************************************************************* - -Grid physics library, www.github.com/paboyle/Grid - -Source file: ./lib/qcd/action/fermion/WilsonKernels.cc - -Copyright (C) 2015 - -Author: Peter Boyle -Author: Peter Boyle -Author: paboyle - -This program is free software; you can redistribute it and/or modify -it under the terms of the GNU General Public License as published by -the Free Software Foundation; either version 2 of the License, or -(at your option) any later version. - -This program is distributed in the hope that it will be useful, -but WITHOUT ANY WARRANTY; without even the implied warranty of -MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the -GNU General Public License for more details. - -You should have received a copy of the GNU General Public License along -with this program; if not, write to the Free Software Foundation, Inc., -51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. - -See the full license in the file "LICENSE" in the top level distribution -directory -*************************************************************************************/ -/* END LEGAL */ -#include -#include -#include - -#ifndef AVX512 -#ifndef QPX -#include -#endif -#endif - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class WilsonKernels; - -NAMESPACE_END(Grid); - diff --git a/Grid/qcd/action/fermion/instantiation/WilsonImplDF/WilsonKernelsInstantiationWilsonImplDF.cc b/Grid/qcd/action/fermion/instantiation/WilsonImplDF/WilsonKernelsInstantiationWilsonImplDF.cc new file mode 120000 index 00000000..01c35e7b --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/WilsonImplDF/WilsonKernelsInstantiationWilsonImplDF.cc @@ -0,0 +1 @@ +../WilsonKernelsInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/WilsonImplDF/WilsonTMFermionInstantiationWilsonImplDF.cc b/Grid/qcd/action/fermion/instantiation/WilsonImplDF/WilsonTMFermionInstantiationWilsonImplDF.cc deleted file mode 100644 index adfa310c..00000000 --- a/Grid/qcd/action/fermion/instantiation/WilsonImplDF/WilsonTMFermionInstantiationWilsonImplDF.cc +++ /dev/null @@ -1,37 +0,0 @@ -/************************************************************************************* - - Grid physics library, www.github.com/paboyle/Grid - - Source file: ./lib/qcd/action/fermion/WilsonTMFermion.cc - - Copyright (C) 2015 - -Author: paboyle - - This program is free software; you can redistribute it and/or modify - it under the terms of the GNU General Public License as published by - the Free Software Foundation; either version 2 of the License, or - (at your option) any later version. - - This program is 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 -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class WilsonTMFermion; - -NAMESPACE_END(Grid); diff --git a/Grid/qcd/action/fermion/instantiation/WilsonImplDF/WilsonTMFermionInstantiationWilsonImplDF.cc b/Grid/qcd/action/fermion/instantiation/WilsonImplDF/WilsonTMFermionInstantiationWilsonImplDF.cc new file mode 120000 index 00000000..d5789bcf --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/WilsonImplDF/WilsonTMFermionInstantiationWilsonImplDF.cc @@ -0,0 +1 @@ +../WilsonTMFermionInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/WilsonImplF/CayleyFermion5DInstantiationWilsonImplF.cc b/Grid/qcd/action/fermion/instantiation/WilsonImplF/CayleyFermion5DInstantiationWilsonImplF.cc deleted file mode 100644 index 5130db9c..00000000 --- a/Grid/qcd/action/fermion/instantiation/WilsonImplF/CayleyFermion5DInstantiationWilsonImplF.cc +++ /dev/null @@ -1,44 +0,0 @@ -/************************************************************************************* - -Grid physics library, www.github.com/paboyle/Grid - -Source file: ./lib/qcd/action/fermion/WilsonKernels.cc - -Copyright (C) 2015 - -Author: Peter Boyle -Author: Peter Boyle -Author: paboyle - -This program is free software; you can redistribute it and/or modify -it under the terms of the GNU General Public License as published by -the Free Software Foundation; either version 2 of the License, or -(at your option) any later version. - -This program is distributed in the hope that it will be useful, -but WITHOUT ANY WARRANTY; without even the implied warranty of -MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the -GNU General Public License for more details. - -You should have received a copy of the GNU General Public License along -with this program; if not, write to the Free Software Foundation, Inc., -51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. - -See the full license in the file "LICENSE" in the top level distribution -directory -*************************************************************************************/ -/* END LEGAL */ -#include -#include -#include - - //#include - //#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class CayleyFermion5D; - -NAMESPACE_END(Grid); - diff --git a/Grid/qcd/action/fermion/instantiation/WilsonImplF/CayleyFermion5DInstantiationWilsonImplF.cc b/Grid/qcd/action/fermion/instantiation/WilsonImplF/CayleyFermion5DInstantiationWilsonImplF.cc new file mode 120000 index 00000000..cb1db625 --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/WilsonImplF/CayleyFermion5DInstantiationWilsonImplF.cc @@ -0,0 +1 @@ +../CayleyFermion5DInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/WilsonImplF/ContinuedFractionFermion5DInstantiationWilsonImplF.cc b/Grid/qcd/action/fermion/instantiation/WilsonImplF/ContinuedFractionFermion5DInstantiationWilsonImplF.cc deleted file mode 100644 index ca0d6cea..00000000 --- a/Grid/qcd/action/fermion/instantiation/WilsonImplF/ContinuedFractionFermion5DInstantiationWilsonImplF.cc +++ /dev/null @@ -1,38 +0,0 @@ -/************************************************************************************* - - Grid physics library, www.github.com/paboyle/Grid - - Source file: ./lib/qcd/action/fermion/ContinuedFractionFermion5D.cc - - Copyright (C) 2015 - -Author: Peter Boyle -Author: Peter Boyle - - This program is free software; you can redistribute it and/or modify - it under the terms of the GNU General Public License as published by - the Free Software Foundation; either version 2 of the License, or - (at your option) any later version. - - This program is distributed in the hope that it will be useful, - but WITHOUT ANY WARRANTY; without even the implied warranty of - MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the - GNU General Public License for more details. - - You should have received a copy of the GNU General Public License along - with this program; if not, write to the Free Software Foundation, Inc., - 51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. - - See the full license in the file "LICENSE" in the top level distribution directory -*************************************************************************************/ -/* END LEGAL */ -#include -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class ContinuedFractionFermion5D; - -NAMESPACE_END(Grid); diff --git a/Grid/qcd/action/fermion/instantiation/WilsonImplF/ContinuedFractionFermion5DInstantiationWilsonImplF.cc b/Grid/qcd/action/fermion/instantiation/WilsonImplF/ContinuedFractionFermion5DInstantiationWilsonImplF.cc new file mode 120000 index 00000000..c2d4b8fc --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/WilsonImplF/ContinuedFractionFermion5DInstantiationWilsonImplF.cc @@ -0,0 +1 @@ +../ContinuedFractionFermion5DInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/WilsonImplF/DomainWallEOFAFermionInstantiationWilsonImplF.cc b/Grid/qcd/action/fermion/instantiation/WilsonImplF/DomainWallEOFAFermionInstantiationWilsonImplF.cc deleted file mode 100644 index f7198131..00000000 --- a/Grid/qcd/action/fermion/instantiation/WilsonImplF/DomainWallEOFAFermionInstantiationWilsonImplF.cc +++ /dev/null @@ -1,44 +0,0 @@ -/************************************************************************************* - -Grid physics library, www.github.com/paboyle/Grid - -Source file: ./lib/qcd/action/fermion/DomainWallEOFAFermion.cc - -Copyright (C) 2017 - -Author: Peter Boyle -Author: Peter Boyle -Author: Peter Boyle -Author: paboyle -Author: David Murphy - -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 -#include -#include -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class DomainWallEOFAFermion; - -NAMESPACE_END(Grid); diff --git a/Grid/qcd/action/fermion/instantiation/WilsonImplF/DomainWallEOFAFermionInstantiationWilsonImplF.cc b/Grid/qcd/action/fermion/instantiation/WilsonImplF/DomainWallEOFAFermionInstantiationWilsonImplF.cc new file mode 120000 index 00000000..2f550a2b --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/WilsonImplF/DomainWallEOFAFermionInstantiationWilsonImplF.cc @@ -0,0 +1 @@ +../DomainWallEOFAFermionInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/WilsonImplF/MobiusEOFAFermionInstantiationWilsonImplF.cc b/Grid/qcd/action/fermion/instantiation/WilsonImplF/MobiusEOFAFermionInstantiationWilsonImplF.cc deleted file mode 100644 index ce7eaac9..00000000 --- a/Grid/qcd/action/fermion/instantiation/WilsonImplF/MobiusEOFAFermionInstantiationWilsonImplF.cc +++ /dev/null @@ -1,44 +0,0 @@ -/************************************************************************************* - -Grid physics library, www.github.com/paboyle/Grid - -Source file: ./lib/qcd/action/fermion/MobiusEOFAFermion.cc - -Copyright (C) 2017 - -Author: Peter Boyle -Author: Peter Boyle -Author: Peter Boyle -Author: paboyle -Author: David Murphy - -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 -#include -#include -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class MobiusEOFAFermion; - -NAMESPACE_END(Grid); diff --git a/Grid/qcd/action/fermion/instantiation/WilsonImplF/MobiusEOFAFermionInstantiationWilsonImplF.cc b/Grid/qcd/action/fermion/instantiation/WilsonImplF/MobiusEOFAFermionInstantiationWilsonImplF.cc new file mode 120000 index 00000000..7a8f1172 --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/WilsonImplF/MobiusEOFAFermionInstantiationWilsonImplF.cc @@ -0,0 +1 @@ +../MobiusEOFAFermionInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/WilsonImplF/PartialFractionFermion5DInstantiationWilsonImplF.cc b/Grid/qcd/action/fermion/instantiation/WilsonImplF/PartialFractionFermion5DInstantiationWilsonImplF.cc deleted file mode 100644 index 757719b6..00000000 --- a/Grid/qcd/action/fermion/instantiation/WilsonImplF/PartialFractionFermion5DInstantiationWilsonImplF.cc +++ /dev/null @@ -1,39 +0,0 @@ -/************************************************************************************* - - Grid physics library, www.github.com/paboyle/Grid - - Source file: ./lib/qcd/action/fermion/PartialFractionFermion5D.cc - - Copyright (C) 2015 - -Author: Peter Boyle -Author: Peter Boyle - - This program is free software; you can redistribute it and/or modify - it under the terms of the GNU General Public License as published by - the Free Software Foundation; either version 2 of the License, or - (at your option) any later version. - - This program is distributed in the hope that it will be useful, - but WITHOUT ANY WARRANTY; without even the implied warranty of - MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the - GNU General Public License for more details. - - You should have received a copy of the GNU General Public License along - with this program; if not, write to the Free Software Foundation, Inc., - 51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. - - See the full license in the file "LICENSE" in the top level distribution directory -*************************************************************************************/ -/* END LEGAL */ -#include -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class PartialFractionFermion5D; - -NAMESPACE_END(Grid); - diff --git a/Grid/qcd/action/fermion/instantiation/WilsonImplF/PartialFractionFermion5DInstantiationWilsonImplF.cc b/Grid/qcd/action/fermion/instantiation/WilsonImplF/PartialFractionFermion5DInstantiationWilsonImplF.cc new file mode 120000 index 00000000..7f4cea71 --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/WilsonImplF/PartialFractionFermion5DInstantiationWilsonImplF.cc @@ -0,0 +1 @@ +../PartialFractionFermion5DInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/WilsonImplF/WilsonCloverFermionInstantiationWilsonImplF.cc b/Grid/qcd/action/fermion/instantiation/WilsonImplF/WilsonCloverFermionInstantiationWilsonImplF.cc deleted file mode 100644 index af99dfb6..00000000 --- a/Grid/qcd/action/fermion/instantiation/WilsonImplF/WilsonCloverFermionInstantiationWilsonImplF.cc +++ /dev/null @@ -1,40 +0,0 @@ -/************************************************************************************* - - Grid physics library, www.github.com/paboyle/Grid - - Source file: ./lib/qcd/action/fermion/WilsonCloverFermion.cc - - Copyright (C) 2017 - - Author: paboyle - Author: Guido Cossu - - 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 -#include -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class WilsonCloverFermion; - -NAMESPACE_END(Grid); diff --git a/Grid/qcd/action/fermion/instantiation/WilsonImplF/WilsonCloverFermionInstantiationWilsonImplF.cc b/Grid/qcd/action/fermion/instantiation/WilsonImplF/WilsonCloverFermionInstantiationWilsonImplF.cc new file mode 120000 index 00000000..9cc05107 --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/WilsonImplF/WilsonCloverFermionInstantiationWilsonImplF.cc @@ -0,0 +1 @@ +../WilsonCloverFermionInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/WilsonImplF/WilsonFermion5DInstantiationWilsonImplF.cc b/Grid/qcd/action/fermion/instantiation/WilsonImplF/WilsonFermion5DInstantiationWilsonImplF.cc deleted file mode 100644 index 0dac989c..00000000 --- a/Grid/qcd/action/fermion/instantiation/WilsonImplF/WilsonFermion5DInstantiationWilsonImplF.cc +++ /dev/null @@ -1,40 +0,0 @@ -/************************************************************************************* - -Grid physics library, www.github.com/paboyle/Grid - -Source file: ./lib/qcd/action/fermion/WilsonKernels.cc - -Copyright (C) 2015 - -Author: Peter Boyle -Author: Peter Boyle -Author: paboyle - -This program is free software; you can redistribute it and/or modify -it under the terms of the GNU General Public License as published by -the Free Software Foundation; either version 2 of the License, or -(at your option) any later version. - -This program is distributed in the hope that it will be useful, -but WITHOUT ANY WARRANTY; without even the implied warranty of -MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the -GNU General Public License for more details. - -You should have received a copy of the GNU General Public License along -with this program; if not, write to the Free Software Foundation, Inc., -51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. - -See the full license in the file "LICENSE" in the top level distribution -directory -*************************************************************************************/ -/* END LEGAL */ -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class WilsonFermion5D; - -NAMESPACE_END(Grid); - diff --git a/Grid/qcd/action/fermion/instantiation/WilsonImplF/WilsonFermion5DInstantiationWilsonImplF.cc b/Grid/qcd/action/fermion/instantiation/WilsonImplF/WilsonFermion5DInstantiationWilsonImplF.cc new file mode 120000 index 00000000..804d0884 --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/WilsonImplF/WilsonFermion5DInstantiationWilsonImplF.cc @@ -0,0 +1 @@ +../WilsonFermion5DInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/WilsonImplF/WilsonFermionInstantiationWilsonImplF.cc b/Grid/qcd/action/fermion/instantiation/WilsonImplF/WilsonFermionInstantiationWilsonImplF.cc deleted file mode 100644 index 6fd9c5ca..00000000 --- a/Grid/qcd/action/fermion/instantiation/WilsonImplF/WilsonFermionInstantiationWilsonImplF.cc +++ /dev/null @@ -1,40 +0,0 @@ -/************************************************************************************* - -Grid physics library, www.github.com/paboyle/Grid - -Source file: ./lib/qcd/action/fermion/WilsonKernels.cc - -Copyright (C) 2015 - -Author: Peter Boyle -Author: Peter Boyle -Author: paboyle - -This program is free software; you can redistribute it and/or modify -it under the terms of the GNU General Public License as published by -the Free Software Foundation; either version 2 of the License, or -(at your option) any later version. - -This program is distributed in the hope that it will be useful, -but WITHOUT ANY WARRANTY; without even the implied warranty of -MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the -GNU General Public License for more details. - -You should have received a copy of the GNU General Public License along -with this program; if not, write to the Free Software Foundation, Inc., -51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. - -See the full license in the file "LICENSE" in the top level distribution -directory -*************************************************************************************/ -/* END LEGAL */ -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class WilsonFermion; - -NAMESPACE_END(Grid); - diff --git a/Grid/qcd/action/fermion/instantiation/WilsonImplF/WilsonFermionInstantiationWilsonImplF.cc b/Grid/qcd/action/fermion/instantiation/WilsonImplF/WilsonFermionInstantiationWilsonImplF.cc new file mode 120000 index 00000000..5f6ab65e --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/WilsonImplF/WilsonFermionInstantiationWilsonImplF.cc @@ -0,0 +1 @@ +../WilsonFermionInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/WilsonImplF/WilsonKernelsInstantiationWilsonImplF.cc b/Grid/qcd/action/fermion/instantiation/WilsonImplF/WilsonKernelsInstantiationWilsonImplF.cc deleted file mode 100644 index 9af5ed85..00000000 --- a/Grid/qcd/action/fermion/instantiation/WilsonImplF/WilsonKernelsInstantiationWilsonImplF.cc +++ /dev/null @@ -1,47 +0,0 @@ -/************************************************************************************* - -Grid physics library, www.github.com/paboyle/Grid - -Source file: ./lib/qcd/action/fermion/WilsonKernels.cc - -Copyright (C) 2015 - -Author: Peter Boyle -Author: Peter Boyle -Author: paboyle - -This program is free software; you can redistribute it and/or modify -it under the terms of the GNU General Public License as published by -the Free Software Foundation; either version 2 of the License, or -(at your option) any later version. - -This program is distributed in the hope that it will be useful, -but WITHOUT ANY WARRANTY; without even the implied warranty of -MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the -GNU General Public License for more details. - -You should have received a copy of the GNU General Public License along -with this program; if not, write to the Free Software Foundation, Inc., -51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. - -See the full license in the file "LICENSE" in the top level distribution -directory -*************************************************************************************/ -/* END LEGAL */ -#include -#include -#include - -#ifndef AVX512 -#ifndef QPX -#include -#endif -#endif - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class WilsonKernels; - -NAMESPACE_END(Grid); - diff --git a/Grid/qcd/action/fermion/instantiation/WilsonImplF/WilsonKernelsInstantiationWilsonImplF.cc b/Grid/qcd/action/fermion/instantiation/WilsonImplF/WilsonKernelsInstantiationWilsonImplF.cc new file mode 120000 index 00000000..01c35e7b --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/WilsonImplF/WilsonKernelsInstantiationWilsonImplF.cc @@ -0,0 +1 @@ +../WilsonKernelsInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/WilsonImplF/WilsonTMFermionInstantiationWilsonImplF.cc b/Grid/qcd/action/fermion/instantiation/WilsonImplF/WilsonTMFermionInstantiationWilsonImplF.cc deleted file mode 100644 index adfa310c..00000000 --- a/Grid/qcd/action/fermion/instantiation/WilsonImplF/WilsonTMFermionInstantiationWilsonImplF.cc +++ /dev/null @@ -1,37 +0,0 @@ -/************************************************************************************* - - Grid physics library, www.github.com/paboyle/Grid - - Source file: ./lib/qcd/action/fermion/WilsonTMFermion.cc - - Copyright (C) 2015 - -Author: paboyle - - This program is free software; you can redistribute it and/or modify - it under the terms of the GNU General Public License as published by - the Free Software Foundation; either version 2 of the License, or - (at your option) any later version. - - This program is 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 -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class WilsonTMFermion; - -NAMESPACE_END(Grid); diff --git a/Grid/qcd/action/fermion/instantiation/WilsonImplF/WilsonTMFermionInstantiationWilsonImplF.cc b/Grid/qcd/action/fermion/instantiation/WilsonImplF/WilsonTMFermionInstantiationWilsonImplF.cc new file mode 120000 index 00000000..d5789bcf --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/WilsonImplF/WilsonTMFermionInstantiationWilsonImplF.cc @@ -0,0 +1 @@ +../WilsonTMFermionInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/WilsonImplFH/CayleyFermion5DInstantiationWilsonImplFH.cc b/Grid/qcd/action/fermion/instantiation/WilsonImplFH/CayleyFermion5DInstantiationWilsonImplFH.cc deleted file mode 100644 index 5130db9c..00000000 --- a/Grid/qcd/action/fermion/instantiation/WilsonImplFH/CayleyFermion5DInstantiationWilsonImplFH.cc +++ /dev/null @@ -1,44 +0,0 @@ -/************************************************************************************* - -Grid physics library, www.github.com/paboyle/Grid - -Source file: ./lib/qcd/action/fermion/WilsonKernels.cc - -Copyright (C) 2015 - -Author: Peter Boyle -Author: Peter Boyle -Author: paboyle - -This program is free software; you can redistribute it and/or modify -it under the terms of the GNU General Public License as published by -the Free Software Foundation; either version 2 of the License, or -(at your option) any later version. - -This program is distributed in the hope that it will be useful, -but WITHOUT ANY WARRANTY; without even the implied warranty of -MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the -GNU General Public License for more details. - -You should have received a copy of the GNU General Public License along -with this program; if not, write to the Free Software Foundation, Inc., -51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. - -See the full license in the file "LICENSE" in the top level distribution -directory -*************************************************************************************/ -/* END LEGAL */ -#include -#include -#include - - //#include - //#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class CayleyFermion5D; - -NAMESPACE_END(Grid); - diff --git a/Grid/qcd/action/fermion/instantiation/WilsonImplFH/CayleyFermion5DInstantiationWilsonImplFH.cc b/Grid/qcd/action/fermion/instantiation/WilsonImplFH/CayleyFermion5DInstantiationWilsonImplFH.cc new file mode 120000 index 00000000..cb1db625 --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/WilsonImplFH/CayleyFermion5DInstantiationWilsonImplFH.cc @@ -0,0 +1 @@ +../CayleyFermion5DInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/WilsonImplFH/ContinuedFractionFermion5DInstantiationWilsonImplFH.cc b/Grid/qcd/action/fermion/instantiation/WilsonImplFH/ContinuedFractionFermion5DInstantiationWilsonImplFH.cc deleted file mode 100644 index ca0d6cea..00000000 --- a/Grid/qcd/action/fermion/instantiation/WilsonImplFH/ContinuedFractionFermion5DInstantiationWilsonImplFH.cc +++ /dev/null @@ -1,38 +0,0 @@ -/************************************************************************************* - - Grid physics library, www.github.com/paboyle/Grid - - Source file: ./lib/qcd/action/fermion/ContinuedFractionFermion5D.cc - - Copyright (C) 2015 - -Author: Peter Boyle -Author: Peter Boyle - - This program is free software; you can redistribute it and/or modify - it under the terms of the GNU General Public License as published by - the Free Software Foundation; either version 2 of the License, or - (at your option) any later version. - - This program is distributed in the hope that it will be useful, - but WITHOUT ANY WARRANTY; without even the implied warranty of - MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the - GNU General Public License for more details. - - You should have received a copy of the GNU General Public License along - with this program; if not, write to the Free Software Foundation, Inc., - 51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. - - See the full license in the file "LICENSE" in the top level distribution directory -*************************************************************************************/ -/* END LEGAL */ -#include -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class ContinuedFractionFermion5D; - -NAMESPACE_END(Grid); diff --git a/Grid/qcd/action/fermion/instantiation/WilsonImplFH/ContinuedFractionFermion5DInstantiationWilsonImplFH.cc b/Grid/qcd/action/fermion/instantiation/WilsonImplFH/ContinuedFractionFermion5DInstantiationWilsonImplFH.cc new file mode 120000 index 00000000..c2d4b8fc --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/WilsonImplFH/ContinuedFractionFermion5DInstantiationWilsonImplFH.cc @@ -0,0 +1 @@ +../ContinuedFractionFermion5DInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/WilsonImplFH/DomainWallEOFAFermionInstantiationWilsonImplFH.cc b/Grid/qcd/action/fermion/instantiation/WilsonImplFH/DomainWallEOFAFermionInstantiationWilsonImplFH.cc deleted file mode 100644 index f7198131..00000000 --- a/Grid/qcd/action/fermion/instantiation/WilsonImplFH/DomainWallEOFAFermionInstantiationWilsonImplFH.cc +++ /dev/null @@ -1,44 +0,0 @@ -/************************************************************************************* - -Grid physics library, www.github.com/paboyle/Grid - -Source file: ./lib/qcd/action/fermion/DomainWallEOFAFermion.cc - -Copyright (C) 2017 - -Author: Peter Boyle -Author: Peter Boyle -Author: Peter Boyle -Author: paboyle -Author: David Murphy - -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 -#include -#include -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class DomainWallEOFAFermion; - -NAMESPACE_END(Grid); diff --git a/Grid/qcd/action/fermion/instantiation/WilsonImplFH/DomainWallEOFAFermionInstantiationWilsonImplFH.cc b/Grid/qcd/action/fermion/instantiation/WilsonImplFH/DomainWallEOFAFermionInstantiationWilsonImplFH.cc new file mode 120000 index 00000000..2f550a2b --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/WilsonImplFH/DomainWallEOFAFermionInstantiationWilsonImplFH.cc @@ -0,0 +1 @@ +../DomainWallEOFAFermionInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/WilsonImplFH/MobiusEOFAFermionInstantiationWilsonImplFH.cc b/Grid/qcd/action/fermion/instantiation/WilsonImplFH/MobiusEOFAFermionInstantiationWilsonImplFH.cc deleted file mode 100644 index ce7eaac9..00000000 --- a/Grid/qcd/action/fermion/instantiation/WilsonImplFH/MobiusEOFAFermionInstantiationWilsonImplFH.cc +++ /dev/null @@ -1,44 +0,0 @@ -/************************************************************************************* - -Grid physics library, www.github.com/paboyle/Grid - -Source file: ./lib/qcd/action/fermion/MobiusEOFAFermion.cc - -Copyright (C) 2017 - -Author: Peter Boyle -Author: Peter Boyle -Author: Peter Boyle -Author: paboyle -Author: David Murphy - -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 -#include -#include -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class MobiusEOFAFermion; - -NAMESPACE_END(Grid); diff --git a/Grid/qcd/action/fermion/instantiation/WilsonImplFH/MobiusEOFAFermionInstantiationWilsonImplFH.cc b/Grid/qcd/action/fermion/instantiation/WilsonImplFH/MobiusEOFAFermionInstantiationWilsonImplFH.cc new file mode 120000 index 00000000..7a8f1172 --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/WilsonImplFH/MobiusEOFAFermionInstantiationWilsonImplFH.cc @@ -0,0 +1 @@ +../MobiusEOFAFermionInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/WilsonImplFH/PartialFractionFermion5DInstantiationWilsonImplFH.cc b/Grid/qcd/action/fermion/instantiation/WilsonImplFH/PartialFractionFermion5DInstantiationWilsonImplFH.cc deleted file mode 100644 index 757719b6..00000000 --- a/Grid/qcd/action/fermion/instantiation/WilsonImplFH/PartialFractionFermion5DInstantiationWilsonImplFH.cc +++ /dev/null @@ -1,39 +0,0 @@ -/************************************************************************************* - - Grid physics library, www.github.com/paboyle/Grid - - Source file: ./lib/qcd/action/fermion/PartialFractionFermion5D.cc - - Copyright (C) 2015 - -Author: Peter Boyle -Author: Peter Boyle - - This program is free software; you can redistribute it and/or modify - it under the terms of the GNU General Public License as published by - the Free Software Foundation; either version 2 of the License, or - (at your option) any later version. - - This program is distributed in the hope that it will be useful, - but WITHOUT ANY WARRANTY; without even the implied warranty of - MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the - GNU General Public License for more details. - - You should have received a copy of the GNU General Public License along - with this program; if not, write to the Free Software Foundation, Inc., - 51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. - - See the full license in the file "LICENSE" in the top level distribution directory -*************************************************************************************/ -/* END LEGAL */ -#include -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class PartialFractionFermion5D; - -NAMESPACE_END(Grid); - diff --git a/Grid/qcd/action/fermion/instantiation/WilsonImplFH/PartialFractionFermion5DInstantiationWilsonImplFH.cc b/Grid/qcd/action/fermion/instantiation/WilsonImplFH/PartialFractionFermion5DInstantiationWilsonImplFH.cc new file mode 120000 index 00000000..7f4cea71 --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/WilsonImplFH/PartialFractionFermion5DInstantiationWilsonImplFH.cc @@ -0,0 +1 @@ +../PartialFractionFermion5DInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/WilsonImplFH/WilsonCloverFermionInstantiationWilsonImplFH.cc b/Grid/qcd/action/fermion/instantiation/WilsonImplFH/WilsonCloverFermionInstantiationWilsonImplFH.cc deleted file mode 100644 index af99dfb6..00000000 --- a/Grid/qcd/action/fermion/instantiation/WilsonImplFH/WilsonCloverFermionInstantiationWilsonImplFH.cc +++ /dev/null @@ -1,40 +0,0 @@ -/************************************************************************************* - - Grid physics library, www.github.com/paboyle/Grid - - Source file: ./lib/qcd/action/fermion/WilsonCloverFermion.cc - - Copyright (C) 2017 - - Author: paboyle - Author: Guido Cossu - - 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 -#include -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class WilsonCloverFermion; - -NAMESPACE_END(Grid); diff --git a/Grid/qcd/action/fermion/instantiation/WilsonImplFH/WilsonCloverFermionInstantiationWilsonImplFH.cc b/Grid/qcd/action/fermion/instantiation/WilsonImplFH/WilsonCloverFermionInstantiationWilsonImplFH.cc new file mode 120000 index 00000000..9cc05107 --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/WilsonImplFH/WilsonCloverFermionInstantiationWilsonImplFH.cc @@ -0,0 +1 @@ +../WilsonCloverFermionInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/WilsonImplFH/WilsonFermion5DInstantiationWilsonImplFH.cc b/Grid/qcd/action/fermion/instantiation/WilsonImplFH/WilsonFermion5DInstantiationWilsonImplFH.cc deleted file mode 100644 index 0dac989c..00000000 --- a/Grid/qcd/action/fermion/instantiation/WilsonImplFH/WilsonFermion5DInstantiationWilsonImplFH.cc +++ /dev/null @@ -1,40 +0,0 @@ -/************************************************************************************* - -Grid physics library, www.github.com/paboyle/Grid - -Source file: ./lib/qcd/action/fermion/WilsonKernels.cc - -Copyright (C) 2015 - -Author: Peter Boyle -Author: Peter Boyle -Author: paboyle - -This program is free software; you can redistribute it and/or modify -it under the terms of the GNU General Public License as published by -the Free Software Foundation; either version 2 of the License, or -(at your option) any later version. - -This program is distributed in the hope that it will be useful, -but WITHOUT ANY WARRANTY; without even the implied warranty of -MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the -GNU General Public License for more details. - -You should have received a copy of the GNU General Public License along -with this program; if not, write to the Free Software Foundation, Inc., -51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. - -See the full license in the file "LICENSE" in the top level distribution -directory -*************************************************************************************/ -/* END LEGAL */ -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class WilsonFermion5D; - -NAMESPACE_END(Grid); - diff --git a/Grid/qcd/action/fermion/instantiation/WilsonImplFH/WilsonFermion5DInstantiationWilsonImplFH.cc b/Grid/qcd/action/fermion/instantiation/WilsonImplFH/WilsonFermion5DInstantiationWilsonImplFH.cc new file mode 120000 index 00000000..804d0884 --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/WilsonImplFH/WilsonFermion5DInstantiationWilsonImplFH.cc @@ -0,0 +1 @@ +../WilsonFermion5DInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/WilsonImplFH/WilsonFermionInstantiationWilsonImplFH.cc b/Grid/qcd/action/fermion/instantiation/WilsonImplFH/WilsonFermionInstantiationWilsonImplFH.cc deleted file mode 100644 index 6fd9c5ca..00000000 --- a/Grid/qcd/action/fermion/instantiation/WilsonImplFH/WilsonFermionInstantiationWilsonImplFH.cc +++ /dev/null @@ -1,40 +0,0 @@ -/************************************************************************************* - -Grid physics library, www.github.com/paboyle/Grid - -Source file: ./lib/qcd/action/fermion/WilsonKernels.cc - -Copyright (C) 2015 - -Author: Peter Boyle -Author: Peter Boyle -Author: paboyle - -This program is free software; you can redistribute it and/or modify -it under the terms of the GNU General Public License as published by -the Free Software Foundation; either version 2 of the License, or -(at your option) any later version. - -This program is distributed in the hope that it will be useful, -but WITHOUT ANY WARRANTY; without even the implied warranty of -MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the -GNU General Public License for more details. - -You should have received a copy of the GNU General Public License along -with this program; if not, write to the Free Software Foundation, Inc., -51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. - -See the full license in the file "LICENSE" in the top level distribution -directory -*************************************************************************************/ -/* END LEGAL */ -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class WilsonFermion; - -NAMESPACE_END(Grid); - diff --git a/Grid/qcd/action/fermion/instantiation/WilsonImplFH/WilsonFermionInstantiationWilsonImplFH.cc b/Grid/qcd/action/fermion/instantiation/WilsonImplFH/WilsonFermionInstantiationWilsonImplFH.cc new file mode 120000 index 00000000..5f6ab65e --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/WilsonImplFH/WilsonFermionInstantiationWilsonImplFH.cc @@ -0,0 +1 @@ +../WilsonFermionInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/WilsonImplFH/WilsonKernelsInstantiationWilsonImplFH.cc b/Grid/qcd/action/fermion/instantiation/WilsonImplFH/WilsonKernelsInstantiationWilsonImplFH.cc deleted file mode 100644 index 9af5ed85..00000000 --- a/Grid/qcd/action/fermion/instantiation/WilsonImplFH/WilsonKernelsInstantiationWilsonImplFH.cc +++ /dev/null @@ -1,47 +0,0 @@ -/************************************************************************************* - -Grid physics library, www.github.com/paboyle/Grid - -Source file: ./lib/qcd/action/fermion/WilsonKernels.cc - -Copyright (C) 2015 - -Author: Peter Boyle -Author: Peter Boyle -Author: paboyle - -This program is free software; you can redistribute it and/or modify -it under the terms of the GNU General Public License as published by -the Free Software Foundation; either version 2 of the License, or -(at your option) any later version. - -This program is distributed in the hope that it will be useful, -but WITHOUT ANY WARRANTY; without even the implied warranty of -MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the -GNU General Public License for more details. - -You should have received a copy of the GNU General Public License along -with this program; if not, write to the Free Software Foundation, Inc., -51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. - -See the full license in the file "LICENSE" in the top level distribution -directory -*************************************************************************************/ -/* END LEGAL */ -#include -#include -#include - -#ifndef AVX512 -#ifndef QPX -#include -#endif -#endif - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class WilsonKernels; - -NAMESPACE_END(Grid); - diff --git a/Grid/qcd/action/fermion/instantiation/WilsonImplFH/WilsonKernelsInstantiationWilsonImplFH.cc b/Grid/qcd/action/fermion/instantiation/WilsonImplFH/WilsonKernelsInstantiationWilsonImplFH.cc new file mode 120000 index 00000000..01c35e7b --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/WilsonImplFH/WilsonKernelsInstantiationWilsonImplFH.cc @@ -0,0 +1 @@ +../WilsonKernelsInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/WilsonImplFH/WilsonTMFermionInstantiationWilsonImplFH.cc b/Grid/qcd/action/fermion/instantiation/WilsonImplFH/WilsonTMFermionInstantiationWilsonImplFH.cc deleted file mode 100644 index adfa310c..00000000 --- a/Grid/qcd/action/fermion/instantiation/WilsonImplFH/WilsonTMFermionInstantiationWilsonImplFH.cc +++ /dev/null @@ -1,37 +0,0 @@ -/************************************************************************************* - - Grid physics library, www.github.com/paboyle/Grid - - Source file: ./lib/qcd/action/fermion/WilsonTMFermion.cc - - Copyright (C) 2015 - -Author: paboyle - - This program is free software; you can redistribute it and/or modify - it under the terms of the GNU General Public License as published by - the Free Software Foundation; either version 2 of the License, or - (at your option) any later version. - - This program is 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 -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class WilsonTMFermion; - -NAMESPACE_END(Grid); diff --git a/Grid/qcd/action/fermion/instantiation/WilsonImplFH/WilsonTMFermionInstantiationWilsonImplFH.cc b/Grid/qcd/action/fermion/instantiation/WilsonImplFH/WilsonTMFermionInstantiationWilsonImplFH.cc new file mode 120000 index 00000000..d5789bcf --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/WilsonImplFH/WilsonTMFermionInstantiationWilsonImplFH.cc @@ -0,0 +1 @@ +../WilsonTMFermionInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/WilsonKernelsInstantiationGparity.cc.master b/Grid/qcd/action/fermion/instantiation/WilsonKernelsInstantiationGparity.cc.master index 75f143cb..1aaf929b 100644 --- a/Grid/qcd/action/fermion/instantiation/WilsonKernelsInstantiationGparity.cc.master +++ b/Grid/qcd/action/fermion/instantiation/WilsonKernelsInstantiationGparity.cc.master @@ -40,33 +40,8 @@ NAMESPACE_BEGIN(Grid); #include "impl.h" -// G-parity requires more specialised implementation. -template <> -void WilsonKernels::ContractConservedCurrentSiteFwd(const SitePropagator &q_in_1, - const SitePropagator &q_in_2, - SitePropagator &q_out, - DoubledGaugeFieldView &U, - unsigned int sU, - unsigned int mu, - bool switch_sign) -{ - assert(0); -} -template <> -void WilsonKernels::ContractConservedCurrentSiteBwd( const SitePropagator &q_in_1, - const SitePropagator &q_in_2, - SitePropagator &q_out, - DoubledGaugeFieldView &U, - unsigned int mu, - unsigned int sU, - bool switch_sign) -{ - assert(0); -} - HAND_SPECIALISE_GPARITY(IMPLEMENTATION); - template class WilsonKernels; diff --git a/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexAntiSymmetricImplD/WilsonCloverFermionInstantiationWilsonTwoIndexAntiSymmetricImplD.cc b/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexAntiSymmetricImplD/WilsonCloverFermionInstantiationWilsonTwoIndexAntiSymmetricImplD.cc deleted file mode 100644 index af99dfb6..00000000 --- a/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexAntiSymmetricImplD/WilsonCloverFermionInstantiationWilsonTwoIndexAntiSymmetricImplD.cc +++ /dev/null @@ -1,40 +0,0 @@ -/************************************************************************************* - - Grid physics library, www.github.com/paboyle/Grid - - Source file: ./lib/qcd/action/fermion/WilsonCloverFermion.cc - - Copyright (C) 2017 - - Author: paboyle - Author: Guido Cossu - - 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 -#include -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class WilsonCloverFermion; - -NAMESPACE_END(Grid); diff --git a/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexAntiSymmetricImplD/WilsonCloverFermionInstantiationWilsonTwoIndexAntiSymmetricImplD.cc b/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexAntiSymmetricImplD/WilsonCloverFermionInstantiationWilsonTwoIndexAntiSymmetricImplD.cc new file mode 120000 index 00000000..9cc05107 --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexAntiSymmetricImplD/WilsonCloverFermionInstantiationWilsonTwoIndexAntiSymmetricImplD.cc @@ -0,0 +1 @@ +../WilsonCloverFermionInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexAntiSymmetricImplD/WilsonFermionInstantiationWilsonTwoIndexAntiSymmetricImplD.cc b/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexAntiSymmetricImplD/WilsonFermionInstantiationWilsonTwoIndexAntiSymmetricImplD.cc deleted file mode 100644 index 6fd9c5ca..00000000 --- a/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexAntiSymmetricImplD/WilsonFermionInstantiationWilsonTwoIndexAntiSymmetricImplD.cc +++ /dev/null @@ -1,40 +0,0 @@ -/************************************************************************************* - -Grid physics library, www.github.com/paboyle/Grid - -Source file: ./lib/qcd/action/fermion/WilsonKernels.cc - -Copyright (C) 2015 - -Author: Peter Boyle -Author: Peter Boyle -Author: paboyle - -This program is free software; you can redistribute it and/or modify -it under the terms of the GNU General Public License as published by -the Free Software Foundation; either version 2 of the License, or -(at your option) any later version. - -This program is distributed in the hope that it will be useful, -but WITHOUT ANY WARRANTY; without even the implied warranty of -MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the -GNU General Public License for more details. - -You should have received a copy of the GNU General Public License along -with this program; if not, write to the Free Software Foundation, Inc., -51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. - -See the full license in the file "LICENSE" in the top level distribution -directory -*************************************************************************************/ -/* END LEGAL */ -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class WilsonFermion; - -NAMESPACE_END(Grid); - diff --git a/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexAntiSymmetricImplD/WilsonFermionInstantiationWilsonTwoIndexAntiSymmetricImplD.cc b/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexAntiSymmetricImplD/WilsonFermionInstantiationWilsonTwoIndexAntiSymmetricImplD.cc new file mode 120000 index 00000000..5f6ab65e --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexAntiSymmetricImplD/WilsonFermionInstantiationWilsonTwoIndexAntiSymmetricImplD.cc @@ -0,0 +1 @@ +../WilsonFermionInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexAntiSymmetricImplD/WilsonKernelsInstantiationWilsonTwoIndexAntiSymmetricImplD.cc b/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexAntiSymmetricImplD/WilsonKernelsInstantiationWilsonTwoIndexAntiSymmetricImplD.cc deleted file mode 100644 index 9af5ed85..00000000 --- a/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexAntiSymmetricImplD/WilsonKernelsInstantiationWilsonTwoIndexAntiSymmetricImplD.cc +++ /dev/null @@ -1,47 +0,0 @@ -/************************************************************************************* - -Grid physics library, www.github.com/paboyle/Grid - -Source file: ./lib/qcd/action/fermion/WilsonKernels.cc - -Copyright (C) 2015 - -Author: Peter Boyle -Author: Peter Boyle -Author: paboyle - -This program is free software; you can redistribute it and/or modify -it under the terms of the GNU General Public License as published by -the Free Software Foundation; either version 2 of the License, or -(at your option) any later version. - -This program is distributed in the hope that it will be useful, -but WITHOUT ANY WARRANTY; without even the implied warranty of -MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the -GNU General Public License for more details. - -You should have received a copy of the GNU General Public License along -with this program; if not, write to the Free Software Foundation, Inc., -51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. - -See the full license in the file "LICENSE" in the top level distribution -directory -*************************************************************************************/ -/* END LEGAL */ -#include -#include -#include - -#ifndef AVX512 -#ifndef QPX -#include -#endif -#endif - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class WilsonKernels; - -NAMESPACE_END(Grid); - diff --git a/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexAntiSymmetricImplD/WilsonKernelsInstantiationWilsonTwoIndexAntiSymmetricImplD.cc b/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexAntiSymmetricImplD/WilsonKernelsInstantiationWilsonTwoIndexAntiSymmetricImplD.cc new file mode 120000 index 00000000..01c35e7b --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexAntiSymmetricImplD/WilsonKernelsInstantiationWilsonTwoIndexAntiSymmetricImplD.cc @@ -0,0 +1 @@ +../WilsonKernelsInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexAntiSymmetricImplD/WilsonTMFermionInstantiationWilsonTwoIndexAntiSymmetricImplD.cc b/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexAntiSymmetricImplD/WilsonTMFermionInstantiationWilsonTwoIndexAntiSymmetricImplD.cc deleted file mode 100644 index adfa310c..00000000 --- a/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexAntiSymmetricImplD/WilsonTMFermionInstantiationWilsonTwoIndexAntiSymmetricImplD.cc +++ /dev/null @@ -1,37 +0,0 @@ -/************************************************************************************* - - Grid physics library, www.github.com/paboyle/Grid - - Source file: ./lib/qcd/action/fermion/WilsonTMFermion.cc - - Copyright (C) 2015 - -Author: paboyle - - This program is free software; you can redistribute it and/or modify - it under the terms of the GNU General Public License as published by - the Free Software Foundation; either version 2 of the License, or - (at your option) any later version. - - This program is 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 -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class WilsonTMFermion; - -NAMESPACE_END(Grid); diff --git a/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexAntiSymmetricImplD/WilsonTMFermionInstantiationWilsonTwoIndexAntiSymmetricImplD.cc b/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexAntiSymmetricImplD/WilsonTMFermionInstantiationWilsonTwoIndexAntiSymmetricImplD.cc new file mode 120000 index 00000000..d5789bcf --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexAntiSymmetricImplD/WilsonTMFermionInstantiationWilsonTwoIndexAntiSymmetricImplD.cc @@ -0,0 +1 @@ +../WilsonTMFermionInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexAntiSymmetricImplF/WilsonCloverFermionInstantiationWilsonTwoIndexAntiSymmetricImplF.cc b/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexAntiSymmetricImplF/WilsonCloverFermionInstantiationWilsonTwoIndexAntiSymmetricImplF.cc deleted file mode 100644 index af99dfb6..00000000 --- a/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexAntiSymmetricImplF/WilsonCloverFermionInstantiationWilsonTwoIndexAntiSymmetricImplF.cc +++ /dev/null @@ -1,40 +0,0 @@ -/************************************************************************************* - - Grid physics library, www.github.com/paboyle/Grid - - Source file: ./lib/qcd/action/fermion/WilsonCloverFermion.cc - - Copyright (C) 2017 - - Author: paboyle - Author: Guido Cossu - - 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 -#include -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class WilsonCloverFermion; - -NAMESPACE_END(Grid); diff --git a/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexAntiSymmetricImplF/WilsonCloverFermionInstantiationWilsonTwoIndexAntiSymmetricImplF.cc b/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexAntiSymmetricImplF/WilsonCloverFermionInstantiationWilsonTwoIndexAntiSymmetricImplF.cc new file mode 120000 index 00000000..9cc05107 --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexAntiSymmetricImplF/WilsonCloverFermionInstantiationWilsonTwoIndexAntiSymmetricImplF.cc @@ -0,0 +1 @@ +../WilsonCloverFermionInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexAntiSymmetricImplF/WilsonFermionInstantiationWilsonTwoIndexAntiSymmetricImplF.cc b/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexAntiSymmetricImplF/WilsonFermionInstantiationWilsonTwoIndexAntiSymmetricImplF.cc deleted file mode 100644 index 6fd9c5ca..00000000 --- a/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexAntiSymmetricImplF/WilsonFermionInstantiationWilsonTwoIndexAntiSymmetricImplF.cc +++ /dev/null @@ -1,40 +0,0 @@ -/************************************************************************************* - -Grid physics library, www.github.com/paboyle/Grid - -Source file: ./lib/qcd/action/fermion/WilsonKernels.cc - -Copyright (C) 2015 - -Author: Peter Boyle -Author: Peter Boyle -Author: paboyle - -This program is free software; you can redistribute it and/or modify -it under the terms of the GNU General Public License as published by -the Free Software Foundation; either version 2 of the License, or -(at your option) any later version. - -This program is distributed in the hope that it will be useful, -but WITHOUT ANY WARRANTY; without even the implied warranty of -MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the -GNU General Public License for more details. - -You should have received a copy of the GNU General Public License along -with this program; if not, write to the Free Software Foundation, Inc., -51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. - -See the full license in the file "LICENSE" in the top level distribution -directory -*************************************************************************************/ -/* END LEGAL */ -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class WilsonFermion; - -NAMESPACE_END(Grid); - diff --git a/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexAntiSymmetricImplF/WilsonFermionInstantiationWilsonTwoIndexAntiSymmetricImplF.cc b/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexAntiSymmetricImplF/WilsonFermionInstantiationWilsonTwoIndexAntiSymmetricImplF.cc new file mode 120000 index 00000000..5f6ab65e --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexAntiSymmetricImplF/WilsonFermionInstantiationWilsonTwoIndexAntiSymmetricImplF.cc @@ -0,0 +1 @@ +../WilsonFermionInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexAntiSymmetricImplF/WilsonKernelsInstantiationWilsonTwoIndexAntiSymmetricImplF.cc b/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexAntiSymmetricImplF/WilsonKernelsInstantiationWilsonTwoIndexAntiSymmetricImplF.cc deleted file mode 100644 index 9af5ed85..00000000 --- a/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexAntiSymmetricImplF/WilsonKernelsInstantiationWilsonTwoIndexAntiSymmetricImplF.cc +++ /dev/null @@ -1,47 +0,0 @@ -/************************************************************************************* - -Grid physics library, www.github.com/paboyle/Grid - -Source file: ./lib/qcd/action/fermion/WilsonKernels.cc - -Copyright (C) 2015 - -Author: Peter Boyle -Author: Peter Boyle -Author: paboyle - -This program is free software; you can redistribute it and/or modify -it under the terms of the GNU General Public License as published by -the Free Software Foundation; either version 2 of the License, or -(at your option) any later version. - -This program is distributed in the hope that it will be useful, -but WITHOUT ANY WARRANTY; without even the implied warranty of -MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the -GNU General Public License for more details. - -You should have received a copy of the GNU General Public License along -with this program; if not, write to the Free Software Foundation, Inc., -51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. - -See the full license in the file "LICENSE" in the top level distribution -directory -*************************************************************************************/ -/* END LEGAL */ -#include -#include -#include - -#ifndef AVX512 -#ifndef QPX -#include -#endif -#endif - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class WilsonKernels; - -NAMESPACE_END(Grid); - diff --git a/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexAntiSymmetricImplF/WilsonKernelsInstantiationWilsonTwoIndexAntiSymmetricImplF.cc b/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexAntiSymmetricImplF/WilsonKernelsInstantiationWilsonTwoIndexAntiSymmetricImplF.cc new file mode 120000 index 00000000..01c35e7b --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexAntiSymmetricImplF/WilsonKernelsInstantiationWilsonTwoIndexAntiSymmetricImplF.cc @@ -0,0 +1 @@ +../WilsonKernelsInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexAntiSymmetricImplF/WilsonTMFermionInstantiationWilsonTwoIndexAntiSymmetricImplF.cc b/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexAntiSymmetricImplF/WilsonTMFermionInstantiationWilsonTwoIndexAntiSymmetricImplF.cc deleted file mode 100644 index adfa310c..00000000 --- a/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexAntiSymmetricImplF/WilsonTMFermionInstantiationWilsonTwoIndexAntiSymmetricImplF.cc +++ /dev/null @@ -1,37 +0,0 @@ -/************************************************************************************* - - Grid physics library, www.github.com/paboyle/Grid - - Source file: ./lib/qcd/action/fermion/WilsonTMFermion.cc - - Copyright (C) 2015 - -Author: paboyle - - This program is free software; you can redistribute it and/or modify - it under the terms of the GNU General Public License as published by - the Free Software Foundation; either version 2 of the License, or - (at your option) any later version. - - This program is 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 -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class WilsonTMFermion; - -NAMESPACE_END(Grid); diff --git a/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexAntiSymmetricImplF/WilsonTMFermionInstantiationWilsonTwoIndexAntiSymmetricImplF.cc b/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexAntiSymmetricImplF/WilsonTMFermionInstantiationWilsonTwoIndexAntiSymmetricImplF.cc new file mode 120000 index 00000000..d5789bcf --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexAntiSymmetricImplF/WilsonTMFermionInstantiationWilsonTwoIndexAntiSymmetricImplF.cc @@ -0,0 +1 @@ +../WilsonTMFermionInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexSymmetricImplD/WilsonCloverFermionInstantiationWilsonTwoIndexSymmetricImplD.cc b/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexSymmetricImplD/WilsonCloverFermionInstantiationWilsonTwoIndexSymmetricImplD.cc deleted file mode 100644 index af99dfb6..00000000 --- a/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexSymmetricImplD/WilsonCloverFermionInstantiationWilsonTwoIndexSymmetricImplD.cc +++ /dev/null @@ -1,40 +0,0 @@ -/************************************************************************************* - - Grid physics library, www.github.com/paboyle/Grid - - Source file: ./lib/qcd/action/fermion/WilsonCloverFermion.cc - - Copyright (C) 2017 - - Author: paboyle - Author: Guido Cossu - - 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 -#include -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class WilsonCloverFermion; - -NAMESPACE_END(Grid); diff --git a/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexSymmetricImplD/WilsonCloverFermionInstantiationWilsonTwoIndexSymmetricImplD.cc b/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexSymmetricImplD/WilsonCloverFermionInstantiationWilsonTwoIndexSymmetricImplD.cc new file mode 120000 index 00000000..9cc05107 --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexSymmetricImplD/WilsonCloverFermionInstantiationWilsonTwoIndexSymmetricImplD.cc @@ -0,0 +1 @@ +../WilsonCloverFermionInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexSymmetricImplD/WilsonFermionInstantiationWilsonTwoIndexSymmetricImplD.cc b/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexSymmetricImplD/WilsonFermionInstantiationWilsonTwoIndexSymmetricImplD.cc deleted file mode 100644 index 6fd9c5ca..00000000 --- a/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexSymmetricImplD/WilsonFermionInstantiationWilsonTwoIndexSymmetricImplD.cc +++ /dev/null @@ -1,40 +0,0 @@ -/************************************************************************************* - -Grid physics library, www.github.com/paboyle/Grid - -Source file: ./lib/qcd/action/fermion/WilsonKernels.cc - -Copyright (C) 2015 - -Author: Peter Boyle -Author: Peter Boyle -Author: paboyle - -This program is free software; you can redistribute it and/or modify -it under the terms of the GNU General Public License as published by -the Free Software Foundation; either version 2 of the License, or -(at your option) any later version. - -This program is distributed in the hope that it will be useful, -but WITHOUT ANY WARRANTY; without even the implied warranty of -MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the -GNU General Public License for more details. - -You should have received a copy of the GNU General Public License along -with this program; if not, write to the Free Software Foundation, Inc., -51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. - -See the full license in the file "LICENSE" in the top level distribution -directory -*************************************************************************************/ -/* END LEGAL */ -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class WilsonFermion; - -NAMESPACE_END(Grid); - diff --git a/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexSymmetricImplD/WilsonFermionInstantiationWilsonTwoIndexSymmetricImplD.cc b/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexSymmetricImplD/WilsonFermionInstantiationWilsonTwoIndexSymmetricImplD.cc new file mode 120000 index 00000000..5f6ab65e --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexSymmetricImplD/WilsonFermionInstantiationWilsonTwoIndexSymmetricImplD.cc @@ -0,0 +1 @@ +../WilsonFermionInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexSymmetricImplD/WilsonKernelsInstantiationWilsonTwoIndexSymmetricImplD.cc b/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexSymmetricImplD/WilsonKernelsInstantiationWilsonTwoIndexSymmetricImplD.cc deleted file mode 100644 index 9af5ed85..00000000 --- a/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexSymmetricImplD/WilsonKernelsInstantiationWilsonTwoIndexSymmetricImplD.cc +++ /dev/null @@ -1,47 +0,0 @@ -/************************************************************************************* - -Grid physics library, www.github.com/paboyle/Grid - -Source file: ./lib/qcd/action/fermion/WilsonKernels.cc - -Copyright (C) 2015 - -Author: Peter Boyle -Author: Peter Boyle -Author: paboyle - -This program is free software; you can redistribute it and/or modify -it under the terms of the GNU General Public License as published by -the Free Software Foundation; either version 2 of the License, or -(at your option) any later version. - -This program is distributed in the hope that it will be useful, -but WITHOUT ANY WARRANTY; without even the implied warranty of -MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the -GNU General Public License for more details. - -You should have received a copy of the GNU General Public License along -with this program; if not, write to the Free Software Foundation, Inc., -51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. - -See the full license in the file "LICENSE" in the top level distribution -directory -*************************************************************************************/ -/* END LEGAL */ -#include -#include -#include - -#ifndef AVX512 -#ifndef QPX -#include -#endif -#endif - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class WilsonKernels; - -NAMESPACE_END(Grid); - diff --git a/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexSymmetricImplD/WilsonKernelsInstantiationWilsonTwoIndexSymmetricImplD.cc b/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexSymmetricImplD/WilsonKernelsInstantiationWilsonTwoIndexSymmetricImplD.cc new file mode 120000 index 00000000..01c35e7b --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexSymmetricImplD/WilsonKernelsInstantiationWilsonTwoIndexSymmetricImplD.cc @@ -0,0 +1 @@ +../WilsonKernelsInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexSymmetricImplD/WilsonTMFermionInstantiationWilsonTwoIndexSymmetricImplD.cc b/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexSymmetricImplD/WilsonTMFermionInstantiationWilsonTwoIndexSymmetricImplD.cc deleted file mode 100644 index adfa310c..00000000 --- a/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexSymmetricImplD/WilsonTMFermionInstantiationWilsonTwoIndexSymmetricImplD.cc +++ /dev/null @@ -1,37 +0,0 @@ -/************************************************************************************* - - Grid physics library, www.github.com/paboyle/Grid - - Source file: ./lib/qcd/action/fermion/WilsonTMFermion.cc - - Copyright (C) 2015 - -Author: paboyle - - This program is free software; you can redistribute it and/or modify - it under the terms of the GNU General Public License as published by - the Free Software Foundation; either version 2 of the License, or - (at your option) any later version. - - This program is 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 -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class WilsonTMFermion; - -NAMESPACE_END(Grid); diff --git a/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexSymmetricImplD/WilsonTMFermionInstantiationWilsonTwoIndexSymmetricImplD.cc b/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexSymmetricImplD/WilsonTMFermionInstantiationWilsonTwoIndexSymmetricImplD.cc new file mode 120000 index 00000000..d5789bcf --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexSymmetricImplD/WilsonTMFermionInstantiationWilsonTwoIndexSymmetricImplD.cc @@ -0,0 +1 @@ +../WilsonTMFermionInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexSymmetricImplF/WilsonCloverFermionInstantiationWilsonTwoIndexSymmetricImplF.cc b/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexSymmetricImplF/WilsonCloverFermionInstantiationWilsonTwoIndexSymmetricImplF.cc deleted file mode 100644 index af99dfb6..00000000 --- a/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexSymmetricImplF/WilsonCloverFermionInstantiationWilsonTwoIndexSymmetricImplF.cc +++ /dev/null @@ -1,40 +0,0 @@ -/************************************************************************************* - - Grid physics library, www.github.com/paboyle/Grid - - Source file: ./lib/qcd/action/fermion/WilsonCloverFermion.cc - - Copyright (C) 2017 - - Author: paboyle - Author: Guido Cossu - - 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 -#include -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class WilsonCloverFermion; - -NAMESPACE_END(Grid); diff --git a/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexSymmetricImplF/WilsonCloverFermionInstantiationWilsonTwoIndexSymmetricImplF.cc b/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexSymmetricImplF/WilsonCloverFermionInstantiationWilsonTwoIndexSymmetricImplF.cc new file mode 120000 index 00000000..9cc05107 --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexSymmetricImplF/WilsonCloverFermionInstantiationWilsonTwoIndexSymmetricImplF.cc @@ -0,0 +1 @@ +../WilsonCloverFermionInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexSymmetricImplF/WilsonFermionInstantiationWilsonTwoIndexSymmetricImplF.cc b/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexSymmetricImplF/WilsonFermionInstantiationWilsonTwoIndexSymmetricImplF.cc deleted file mode 100644 index 6fd9c5ca..00000000 --- a/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexSymmetricImplF/WilsonFermionInstantiationWilsonTwoIndexSymmetricImplF.cc +++ /dev/null @@ -1,40 +0,0 @@ -/************************************************************************************* - -Grid physics library, www.github.com/paboyle/Grid - -Source file: ./lib/qcd/action/fermion/WilsonKernels.cc - -Copyright (C) 2015 - -Author: Peter Boyle -Author: Peter Boyle -Author: paboyle - -This program is free software; you can redistribute it and/or modify -it under the terms of the GNU General Public License as published by -the Free Software Foundation; either version 2 of the License, or -(at your option) any later version. - -This program is distributed in the hope that it will be useful, -but WITHOUT ANY WARRANTY; without even the implied warranty of -MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the -GNU General Public License for more details. - -You should have received a copy of the GNU General Public License along -with this program; if not, write to the Free Software Foundation, Inc., -51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. - -See the full license in the file "LICENSE" in the top level distribution -directory -*************************************************************************************/ -/* END LEGAL */ -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class WilsonFermion; - -NAMESPACE_END(Grid); - diff --git a/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexSymmetricImplF/WilsonFermionInstantiationWilsonTwoIndexSymmetricImplF.cc b/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexSymmetricImplF/WilsonFermionInstantiationWilsonTwoIndexSymmetricImplF.cc new file mode 120000 index 00000000..5f6ab65e --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexSymmetricImplF/WilsonFermionInstantiationWilsonTwoIndexSymmetricImplF.cc @@ -0,0 +1 @@ +../WilsonFermionInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexSymmetricImplF/WilsonKernelsInstantiationWilsonTwoIndexSymmetricImplF.cc b/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexSymmetricImplF/WilsonKernelsInstantiationWilsonTwoIndexSymmetricImplF.cc deleted file mode 100644 index 9af5ed85..00000000 --- a/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexSymmetricImplF/WilsonKernelsInstantiationWilsonTwoIndexSymmetricImplF.cc +++ /dev/null @@ -1,47 +0,0 @@ -/************************************************************************************* - -Grid physics library, www.github.com/paboyle/Grid - -Source file: ./lib/qcd/action/fermion/WilsonKernels.cc - -Copyright (C) 2015 - -Author: Peter Boyle -Author: Peter Boyle -Author: paboyle - -This program is free software; you can redistribute it and/or modify -it under the terms of the GNU General Public License as published by -the Free Software Foundation; either version 2 of the License, or -(at your option) any later version. - -This program is distributed in the hope that it will be useful, -but WITHOUT ANY WARRANTY; without even the implied warranty of -MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the -GNU General Public License for more details. - -You should have received a copy of the GNU General Public License along -with this program; if not, write to the Free Software Foundation, Inc., -51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. - -See the full license in the file "LICENSE" in the top level distribution -directory -*************************************************************************************/ -/* END LEGAL */ -#include -#include -#include - -#ifndef AVX512 -#ifndef QPX -#include -#endif -#endif - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class WilsonKernels; - -NAMESPACE_END(Grid); - diff --git a/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexSymmetricImplF/WilsonKernelsInstantiationWilsonTwoIndexSymmetricImplF.cc b/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexSymmetricImplF/WilsonKernelsInstantiationWilsonTwoIndexSymmetricImplF.cc new file mode 120000 index 00000000..01c35e7b --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexSymmetricImplF/WilsonKernelsInstantiationWilsonTwoIndexSymmetricImplF.cc @@ -0,0 +1 @@ +../WilsonKernelsInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexSymmetricImplF/WilsonTMFermionInstantiationWilsonTwoIndexSymmetricImplF.cc b/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexSymmetricImplF/WilsonTMFermionInstantiationWilsonTwoIndexSymmetricImplF.cc deleted file mode 100644 index adfa310c..00000000 --- a/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexSymmetricImplF/WilsonTMFermionInstantiationWilsonTwoIndexSymmetricImplF.cc +++ /dev/null @@ -1,37 +0,0 @@ -/************************************************************************************* - - Grid physics library, www.github.com/paboyle/Grid - - Source file: ./lib/qcd/action/fermion/WilsonTMFermion.cc - - Copyright (C) 2015 - -Author: paboyle - - This program is free software; you can redistribute it and/or modify - it under the terms of the GNU General Public License as published by - the Free Software Foundation; either version 2 of the License, or - (at your option) any later version. - - This program is 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 -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class WilsonTMFermion; - -NAMESPACE_END(Grid); diff --git a/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexSymmetricImplF/WilsonTMFermionInstantiationWilsonTwoIndexSymmetricImplF.cc b/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexSymmetricImplF/WilsonTMFermionInstantiationWilsonTwoIndexSymmetricImplF.cc new file mode 120000 index 00000000..d5789bcf --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/WilsonTwoIndexSymmetricImplF/WilsonTMFermionInstantiationWilsonTwoIndexSymmetricImplF.cc @@ -0,0 +1 @@ +../WilsonTMFermionInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/ZWilsonImplD/CayleyFermion5DInstantiationZWilsonImplD.cc b/Grid/qcd/action/fermion/instantiation/ZWilsonImplD/CayleyFermion5DInstantiationZWilsonImplD.cc deleted file mode 100644 index 5130db9c..00000000 --- a/Grid/qcd/action/fermion/instantiation/ZWilsonImplD/CayleyFermion5DInstantiationZWilsonImplD.cc +++ /dev/null @@ -1,44 +0,0 @@ -/************************************************************************************* - -Grid physics library, www.github.com/paboyle/Grid - -Source file: ./lib/qcd/action/fermion/WilsonKernels.cc - -Copyright (C) 2015 - -Author: Peter Boyle -Author: Peter Boyle -Author: paboyle - -This program is free software; you can redistribute it and/or modify -it under the terms of the GNU General Public License as published by -the Free Software Foundation; either version 2 of the License, or -(at your option) any later version. - -This program is distributed in the hope that it will be useful, -but WITHOUT ANY WARRANTY; without even the implied warranty of -MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the -GNU General Public License for more details. - -You should have received a copy of the GNU General Public License along -with this program; if not, write to the Free Software Foundation, Inc., -51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. - -See the full license in the file "LICENSE" in the top level distribution -directory -*************************************************************************************/ -/* END LEGAL */ -#include -#include -#include - - //#include - //#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class CayleyFermion5D; - -NAMESPACE_END(Grid); - diff --git a/Grid/qcd/action/fermion/instantiation/ZWilsonImplD/CayleyFermion5DInstantiationZWilsonImplD.cc b/Grid/qcd/action/fermion/instantiation/ZWilsonImplD/CayleyFermion5DInstantiationZWilsonImplD.cc new file mode 120000 index 00000000..cb1db625 --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/ZWilsonImplD/CayleyFermion5DInstantiationZWilsonImplD.cc @@ -0,0 +1 @@ +../CayleyFermion5DInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/ZWilsonImplD/ContinuedFractionFermion5DInstantiationZWilsonImplD.cc b/Grid/qcd/action/fermion/instantiation/ZWilsonImplD/ContinuedFractionFermion5DInstantiationZWilsonImplD.cc deleted file mode 100644 index ca0d6cea..00000000 --- a/Grid/qcd/action/fermion/instantiation/ZWilsonImplD/ContinuedFractionFermion5DInstantiationZWilsonImplD.cc +++ /dev/null @@ -1,38 +0,0 @@ -/************************************************************************************* - - Grid physics library, www.github.com/paboyle/Grid - - Source file: ./lib/qcd/action/fermion/ContinuedFractionFermion5D.cc - - Copyright (C) 2015 - -Author: Peter Boyle -Author: Peter Boyle - - This program is free software; you can redistribute it and/or modify - it under the terms of the GNU General Public License as published by - the Free Software Foundation; either version 2 of the License, or - (at your option) any later version. - - This program is distributed in the hope that it will be useful, - but WITHOUT ANY WARRANTY; without even the implied warranty of - MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the - GNU General Public License for more details. - - You should have received a copy of the GNU General Public License along - with this program; if not, write to the Free Software Foundation, Inc., - 51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. - - See the full license in the file "LICENSE" in the top level distribution directory -*************************************************************************************/ -/* END LEGAL */ -#include -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class ContinuedFractionFermion5D; - -NAMESPACE_END(Grid); diff --git a/Grid/qcd/action/fermion/instantiation/ZWilsonImplD/ContinuedFractionFermion5DInstantiationZWilsonImplD.cc b/Grid/qcd/action/fermion/instantiation/ZWilsonImplD/ContinuedFractionFermion5DInstantiationZWilsonImplD.cc new file mode 120000 index 00000000..c2d4b8fc --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/ZWilsonImplD/ContinuedFractionFermion5DInstantiationZWilsonImplD.cc @@ -0,0 +1 @@ +../ContinuedFractionFermion5DInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/ZWilsonImplD/DomainWallEOFAFermionInstantiationZWilsonImplD.cc b/Grid/qcd/action/fermion/instantiation/ZWilsonImplD/DomainWallEOFAFermionInstantiationZWilsonImplD.cc deleted file mode 100644 index f7198131..00000000 --- a/Grid/qcd/action/fermion/instantiation/ZWilsonImplD/DomainWallEOFAFermionInstantiationZWilsonImplD.cc +++ /dev/null @@ -1,44 +0,0 @@ -/************************************************************************************* - -Grid physics library, www.github.com/paboyle/Grid - -Source file: ./lib/qcd/action/fermion/DomainWallEOFAFermion.cc - -Copyright (C) 2017 - -Author: Peter Boyle -Author: Peter Boyle -Author: Peter Boyle -Author: paboyle -Author: David Murphy - -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 -#include -#include -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class DomainWallEOFAFermion; - -NAMESPACE_END(Grid); diff --git a/Grid/qcd/action/fermion/instantiation/ZWilsonImplD/DomainWallEOFAFermionInstantiationZWilsonImplD.cc b/Grid/qcd/action/fermion/instantiation/ZWilsonImplD/DomainWallEOFAFermionInstantiationZWilsonImplD.cc new file mode 120000 index 00000000..2f550a2b --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/ZWilsonImplD/DomainWallEOFAFermionInstantiationZWilsonImplD.cc @@ -0,0 +1 @@ +../DomainWallEOFAFermionInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/ZWilsonImplD/MobiusEOFAFermionInstantiationZWilsonImplD.cc b/Grid/qcd/action/fermion/instantiation/ZWilsonImplD/MobiusEOFAFermionInstantiationZWilsonImplD.cc deleted file mode 100644 index ce7eaac9..00000000 --- a/Grid/qcd/action/fermion/instantiation/ZWilsonImplD/MobiusEOFAFermionInstantiationZWilsonImplD.cc +++ /dev/null @@ -1,44 +0,0 @@ -/************************************************************************************* - -Grid physics library, www.github.com/paboyle/Grid - -Source file: ./lib/qcd/action/fermion/MobiusEOFAFermion.cc - -Copyright (C) 2017 - -Author: Peter Boyle -Author: Peter Boyle -Author: Peter Boyle -Author: paboyle -Author: David Murphy - -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 -#include -#include -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class MobiusEOFAFermion; - -NAMESPACE_END(Grid); diff --git a/Grid/qcd/action/fermion/instantiation/ZWilsonImplD/MobiusEOFAFermionInstantiationZWilsonImplD.cc b/Grid/qcd/action/fermion/instantiation/ZWilsonImplD/MobiusEOFAFermionInstantiationZWilsonImplD.cc new file mode 120000 index 00000000..7a8f1172 --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/ZWilsonImplD/MobiusEOFAFermionInstantiationZWilsonImplD.cc @@ -0,0 +1 @@ +../MobiusEOFAFermionInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/ZWilsonImplD/PartialFractionFermion5DInstantiationZWilsonImplD.cc b/Grid/qcd/action/fermion/instantiation/ZWilsonImplD/PartialFractionFermion5DInstantiationZWilsonImplD.cc deleted file mode 100644 index 757719b6..00000000 --- a/Grid/qcd/action/fermion/instantiation/ZWilsonImplD/PartialFractionFermion5DInstantiationZWilsonImplD.cc +++ /dev/null @@ -1,39 +0,0 @@ -/************************************************************************************* - - Grid physics library, www.github.com/paboyle/Grid - - Source file: ./lib/qcd/action/fermion/PartialFractionFermion5D.cc - - Copyright (C) 2015 - -Author: Peter Boyle -Author: Peter Boyle - - This program is free software; you can redistribute it and/or modify - it under the terms of the GNU General Public License as published by - the Free Software Foundation; either version 2 of the License, or - (at your option) any later version. - - This program is distributed in the hope that it will be useful, - but WITHOUT ANY WARRANTY; without even the implied warranty of - MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the - GNU General Public License for more details. - - You should have received a copy of the GNU General Public License along - with this program; if not, write to the Free Software Foundation, Inc., - 51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. - - See the full license in the file "LICENSE" in the top level distribution directory -*************************************************************************************/ -/* END LEGAL */ -#include -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class PartialFractionFermion5D; - -NAMESPACE_END(Grid); - diff --git a/Grid/qcd/action/fermion/instantiation/ZWilsonImplD/PartialFractionFermion5DInstantiationZWilsonImplD.cc b/Grid/qcd/action/fermion/instantiation/ZWilsonImplD/PartialFractionFermion5DInstantiationZWilsonImplD.cc new file mode 120000 index 00000000..7f4cea71 --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/ZWilsonImplD/PartialFractionFermion5DInstantiationZWilsonImplD.cc @@ -0,0 +1 @@ +../PartialFractionFermion5DInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/ZWilsonImplD/WilsonFermion5DInstantiationZWilsonImplD.cc b/Grid/qcd/action/fermion/instantiation/ZWilsonImplD/WilsonFermion5DInstantiationZWilsonImplD.cc deleted file mode 100644 index 0dac989c..00000000 --- a/Grid/qcd/action/fermion/instantiation/ZWilsonImplD/WilsonFermion5DInstantiationZWilsonImplD.cc +++ /dev/null @@ -1,40 +0,0 @@ -/************************************************************************************* - -Grid physics library, www.github.com/paboyle/Grid - -Source file: ./lib/qcd/action/fermion/WilsonKernels.cc - -Copyright (C) 2015 - -Author: Peter Boyle -Author: Peter Boyle -Author: paboyle - -This program is free software; you can redistribute it and/or modify -it under the terms of the GNU General Public License as published by -the Free Software Foundation; either version 2 of the License, or -(at your option) any later version. - -This program is distributed in the hope that it will be useful, -but WITHOUT ANY WARRANTY; without even the implied warranty of -MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the -GNU General Public License for more details. - -You should have received a copy of the GNU General Public License along -with this program; if not, write to the Free Software Foundation, Inc., -51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. - -See the full license in the file "LICENSE" in the top level distribution -directory -*************************************************************************************/ -/* END LEGAL */ -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class WilsonFermion5D; - -NAMESPACE_END(Grid); - diff --git a/Grid/qcd/action/fermion/instantiation/ZWilsonImplD/WilsonFermion5DInstantiationZWilsonImplD.cc b/Grid/qcd/action/fermion/instantiation/ZWilsonImplD/WilsonFermion5DInstantiationZWilsonImplD.cc new file mode 120000 index 00000000..804d0884 --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/ZWilsonImplD/WilsonFermion5DInstantiationZWilsonImplD.cc @@ -0,0 +1 @@ +../WilsonFermion5DInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/ZWilsonImplD/WilsonKernelsInstantiationZWilsonImplD.cc b/Grid/qcd/action/fermion/instantiation/ZWilsonImplD/WilsonKernelsInstantiationZWilsonImplD.cc deleted file mode 100644 index 9af5ed85..00000000 --- a/Grid/qcd/action/fermion/instantiation/ZWilsonImplD/WilsonKernelsInstantiationZWilsonImplD.cc +++ /dev/null @@ -1,47 +0,0 @@ -/************************************************************************************* - -Grid physics library, www.github.com/paboyle/Grid - -Source file: ./lib/qcd/action/fermion/WilsonKernels.cc - -Copyright (C) 2015 - -Author: Peter Boyle -Author: Peter Boyle -Author: paboyle - -This program is free software; you can redistribute it and/or modify -it under the terms of the GNU General Public License as published by -the Free Software Foundation; either version 2 of the License, or -(at your option) any later version. - -This program is distributed in the hope that it will be useful, -but WITHOUT ANY WARRANTY; without even the implied warranty of -MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the -GNU General Public License for more details. - -You should have received a copy of the GNU General Public License along -with this program; if not, write to the Free Software Foundation, Inc., -51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. - -See the full license in the file "LICENSE" in the top level distribution -directory -*************************************************************************************/ -/* END LEGAL */ -#include -#include -#include - -#ifndef AVX512 -#ifndef QPX -#include -#endif -#endif - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class WilsonKernels; - -NAMESPACE_END(Grid); - diff --git a/Grid/qcd/action/fermion/instantiation/ZWilsonImplD/WilsonKernelsInstantiationZWilsonImplD.cc b/Grid/qcd/action/fermion/instantiation/ZWilsonImplD/WilsonKernelsInstantiationZWilsonImplD.cc new file mode 120000 index 00000000..01c35e7b --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/ZWilsonImplD/WilsonKernelsInstantiationZWilsonImplD.cc @@ -0,0 +1 @@ +../WilsonKernelsInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/ZWilsonImplDF/CayleyFermion5DInstantiationZWilsonImplDF.cc b/Grid/qcd/action/fermion/instantiation/ZWilsonImplDF/CayleyFermion5DInstantiationZWilsonImplDF.cc deleted file mode 100644 index 5130db9c..00000000 --- a/Grid/qcd/action/fermion/instantiation/ZWilsonImplDF/CayleyFermion5DInstantiationZWilsonImplDF.cc +++ /dev/null @@ -1,44 +0,0 @@ -/************************************************************************************* - -Grid physics library, www.github.com/paboyle/Grid - -Source file: ./lib/qcd/action/fermion/WilsonKernels.cc - -Copyright (C) 2015 - -Author: Peter Boyle -Author: Peter Boyle -Author: paboyle - -This program is free software; you can redistribute it and/or modify -it under the terms of the GNU General Public License as published by -the Free Software Foundation; either version 2 of the License, or -(at your option) any later version. - -This program is distributed in the hope that it will be useful, -but WITHOUT ANY WARRANTY; without even the implied warranty of -MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the -GNU General Public License for more details. - -You should have received a copy of the GNU General Public License along -with this program; if not, write to the Free Software Foundation, Inc., -51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. - -See the full license in the file "LICENSE" in the top level distribution -directory -*************************************************************************************/ -/* END LEGAL */ -#include -#include -#include - - //#include - //#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class CayleyFermion5D; - -NAMESPACE_END(Grid); - diff --git a/Grid/qcd/action/fermion/instantiation/ZWilsonImplDF/CayleyFermion5DInstantiationZWilsonImplDF.cc b/Grid/qcd/action/fermion/instantiation/ZWilsonImplDF/CayleyFermion5DInstantiationZWilsonImplDF.cc new file mode 120000 index 00000000..cb1db625 --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/ZWilsonImplDF/CayleyFermion5DInstantiationZWilsonImplDF.cc @@ -0,0 +1 @@ +../CayleyFermion5DInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/ZWilsonImplDF/ContinuedFractionFermion5DInstantiationZWilsonImplDF.cc b/Grid/qcd/action/fermion/instantiation/ZWilsonImplDF/ContinuedFractionFermion5DInstantiationZWilsonImplDF.cc deleted file mode 100644 index ca0d6cea..00000000 --- a/Grid/qcd/action/fermion/instantiation/ZWilsonImplDF/ContinuedFractionFermion5DInstantiationZWilsonImplDF.cc +++ /dev/null @@ -1,38 +0,0 @@ -/************************************************************************************* - - Grid physics library, www.github.com/paboyle/Grid - - Source file: ./lib/qcd/action/fermion/ContinuedFractionFermion5D.cc - - Copyright (C) 2015 - -Author: Peter Boyle -Author: Peter Boyle - - This program is free software; you can redistribute it and/or modify - it under the terms of the GNU General Public License as published by - the Free Software Foundation; either version 2 of the License, or - (at your option) any later version. - - This program is distributed in the hope that it will be useful, - but WITHOUT ANY WARRANTY; without even the implied warranty of - MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the - GNU General Public License for more details. - - You should have received a copy of the GNU General Public License along - with this program; if not, write to the Free Software Foundation, Inc., - 51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. - - See the full license in the file "LICENSE" in the top level distribution directory -*************************************************************************************/ -/* END LEGAL */ -#include -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class ContinuedFractionFermion5D; - -NAMESPACE_END(Grid); diff --git a/Grid/qcd/action/fermion/instantiation/ZWilsonImplDF/ContinuedFractionFermion5DInstantiationZWilsonImplDF.cc b/Grid/qcd/action/fermion/instantiation/ZWilsonImplDF/ContinuedFractionFermion5DInstantiationZWilsonImplDF.cc new file mode 120000 index 00000000..c2d4b8fc --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/ZWilsonImplDF/ContinuedFractionFermion5DInstantiationZWilsonImplDF.cc @@ -0,0 +1 @@ +../ContinuedFractionFermion5DInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/ZWilsonImplDF/DomainWallEOFAFermionInstantiationZWilsonImplDF.cc b/Grid/qcd/action/fermion/instantiation/ZWilsonImplDF/DomainWallEOFAFermionInstantiationZWilsonImplDF.cc deleted file mode 100644 index f7198131..00000000 --- a/Grid/qcd/action/fermion/instantiation/ZWilsonImplDF/DomainWallEOFAFermionInstantiationZWilsonImplDF.cc +++ /dev/null @@ -1,44 +0,0 @@ -/************************************************************************************* - -Grid physics library, www.github.com/paboyle/Grid - -Source file: ./lib/qcd/action/fermion/DomainWallEOFAFermion.cc - -Copyright (C) 2017 - -Author: Peter Boyle -Author: Peter Boyle -Author: Peter Boyle -Author: paboyle -Author: David Murphy - -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 -#include -#include -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class DomainWallEOFAFermion; - -NAMESPACE_END(Grid); diff --git a/Grid/qcd/action/fermion/instantiation/ZWilsonImplDF/DomainWallEOFAFermionInstantiationZWilsonImplDF.cc b/Grid/qcd/action/fermion/instantiation/ZWilsonImplDF/DomainWallEOFAFermionInstantiationZWilsonImplDF.cc new file mode 120000 index 00000000..2f550a2b --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/ZWilsonImplDF/DomainWallEOFAFermionInstantiationZWilsonImplDF.cc @@ -0,0 +1 @@ +../DomainWallEOFAFermionInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/ZWilsonImplDF/MobiusEOFAFermionInstantiationZWilsonImplDF.cc b/Grid/qcd/action/fermion/instantiation/ZWilsonImplDF/MobiusEOFAFermionInstantiationZWilsonImplDF.cc deleted file mode 100644 index ce7eaac9..00000000 --- a/Grid/qcd/action/fermion/instantiation/ZWilsonImplDF/MobiusEOFAFermionInstantiationZWilsonImplDF.cc +++ /dev/null @@ -1,44 +0,0 @@ -/************************************************************************************* - -Grid physics library, www.github.com/paboyle/Grid - -Source file: ./lib/qcd/action/fermion/MobiusEOFAFermion.cc - -Copyright (C) 2017 - -Author: Peter Boyle -Author: Peter Boyle -Author: Peter Boyle -Author: paboyle -Author: David Murphy - -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 -#include -#include -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class MobiusEOFAFermion; - -NAMESPACE_END(Grid); diff --git a/Grid/qcd/action/fermion/instantiation/ZWilsonImplDF/MobiusEOFAFermionInstantiationZWilsonImplDF.cc b/Grid/qcd/action/fermion/instantiation/ZWilsonImplDF/MobiusEOFAFermionInstantiationZWilsonImplDF.cc new file mode 120000 index 00000000..7a8f1172 --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/ZWilsonImplDF/MobiusEOFAFermionInstantiationZWilsonImplDF.cc @@ -0,0 +1 @@ +../MobiusEOFAFermionInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/ZWilsonImplDF/PartialFractionFermion5DInstantiationZWilsonImplDF.cc b/Grid/qcd/action/fermion/instantiation/ZWilsonImplDF/PartialFractionFermion5DInstantiationZWilsonImplDF.cc deleted file mode 100644 index 757719b6..00000000 --- a/Grid/qcd/action/fermion/instantiation/ZWilsonImplDF/PartialFractionFermion5DInstantiationZWilsonImplDF.cc +++ /dev/null @@ -1,39 +0,0 @@ -/************************************************************************************* - - Grid physics library, www.github.com/paboyle/Grid - - Source file: ./lib/qcd/action/fermion/PartialFractionFermion5D.cc - - Copyright (C) 2015 - -Author: Peter Boyle -Author: Peter Boyle - - This program is free software; you can redistribute it and/or modify - it under the terms of the GNU General Public License as published by - the Free Software Foundation; either version 2 of the License, or - (at your option) any later version. - - This program is distributed in the hope that it will be useful, - but WITHOUT ANY WARRANTY; without even the implied warranty of - MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the - GNU General Public License for more details. - - You should have received a copy of the GNU General Public License along - with this program; if not, write to the Free Software Foundation, Inc., - 51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. - - See the full license in the file "LICENSE" in the top level distribution directory -*************************************************************************************/ -/* END LEGAL */ -#include -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class PartialFractionFermion5D; - -NAMESPACE_END(Grid); - diff --git a/Grid/qcd/action/fermion/instantiation/ZWilsonImplDF/PartialFractionFermion5DInstantiationZWilsonImplDF.cc b/Grid/qcd/action/fermion/instantiation/ZWilsonImplDF/PartialFractionFermion5DInstantiationZWilsonImplDF.cc new file mode 120000 index 00000000..7f4cea71 --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/ZWilsonImplDF/PartialFractionFermion5DInstantiationZWilsonImplDF.cc @@ -0,0 +1 @@ +../PartialFractionFermion5DInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/ZWilsonImplDF/WilsonFermion5DInstantiationZWilsonImplDF.cc b/Grid/qcd/action/fermion/instantiation/ZWilsonImplDF/WilsonFermion5DInstantiationZWilsonImplDF.cc deleted file mode 100644 index 0dac989c..00000000 --- a/Grid/qcd/action/fermion/instantiation/ZWilsonImplDF/WilsonFermion5DInstantiationZWilsonImplDF.cc +++ /dev/null @@ -1,40 +0,0 @@ -/************************************************************************************* - -Grid physics library, www.github.com/paboyle/Grid - -Source file: ./lib/qcd/action/fermion/WilsonKernels.cc - -Copyright (C) 2015 - -Author: Peter Boyle -Author: Peter Boyle -Author: paboyle - -This program is free software; you can redistribute it and/or modify -it under the terms of the GNU General Public License as published by -the Free Software Foundation; either version 2 of the License, or -(at your option) any later version. - -This program is distributed in the hope that it will be useful, -but WITHOUT ANY WARRANTY; without even the implied warranty of -MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the -GNU General Public License for more details. - -You should have received a copy of the GNU General Public License along -with this program; if not, write to the Free Software Foundation, Inc., -51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. - -See the full license in the file "LICENSE" in the top level distribution -directory -*************************************************************************************/ -/* END LEGAL */ -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class WilsonFermion5D; - -NAMESPACE_END(Grid); - diff --git a/Grid/qcd/action/fermion/instantiation/ZWilsonImplDF/WilsonFermion5DInstantiationZWilsonImplDF.cc b/Grid/qcd/action/fermion/instantiation/ZWilsonImplDF/WilsonFermion5DInstantiationZWilsonImplDF.cc new file mode 120000 index 00000000..804d0884 --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/ZWilsonImplDF/WilsonFermion5DInstantiationZWilsonImplDF.cc @@ -0,0 +1 @@ +../WilsonFermion5DInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/ZWilsonImplDF/WilsonKernelsInstantiationZWilsonImplDF.cc b/Grid/qcd/action/fermion/instantiation/ZWilsonImplDF/WilsonKernelsInstantiationZWilsonImplDF.cc deleted file mode 100644 index 9af5ed85..00000000 --- a/Grid/qcd/action/fermion/instantiation/ZWilsonImplDF/WilsonKernelsInstantiationZWilsonImplDF.cc +++ /dev/null @@ -1,47 +0,0 @@ -/************************************************************************************* - -Grid physics library, www.github.com/paboyle/Grid - -Source file: ./lib/qcd/action/fermion/WilsonKernels.cc - -Copyright (C) 2015 - -Author: Peter Boyle -Author: Peter Boyle -Author: paboyle - -This program is free software; you can redistribute it and/or modify -it under the terms of the GNU General Public License as published by -the Free Software Foundation; either version 2 of the License, or -(at your option) any later version. - -This program is distributed in the hope that it will be useful, -but WITHOUT ANY WARRANTY; without even the implied warranty of -MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the -GNU General Public License for more details. - -You should have received a copy of the GNU General Public License along -with this program; if not, write to the Free Software Foundation, Inc., -51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. - -See the full license in the file "LICENSE" in the top level distribution -directory -*************************************************************************************/ -/* END LEGAL */ -#include -#include -#include - -#ifndef AVX512 -#ifndef QPX -#include -#endif -#endif - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class WilsonKernels; - -NAMESPACE_END(Grid); - diff --git a/Grid/qcd/action/fermion/instantiation/ZWilsonImplDF/WilsonKernelsInstantiationZWilsonImplDF.cc b/Grid/qcd/action/fermion/instantiation/ZWilsonImplDF/WilsonKernelsInstantiationZWilsonImplDF.cc new file mode 120000 index 00000000..01c35e7b --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/ZWilsonImplDF/WilsonKernelsInstantiationZWilsonImplDF.cc @@ -0,0 +1 @@ +../WilsonKernelsInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/ZWilsonImplF/CayleyFermion5DInstantiationZWilsonImplF.cc b/Grid/qcd/action/fermion/instantiation/ZWilsonImplF/CayleyFermion5DInstantiationZWilsonImplF.cc deleted file mode 100644 index 5130db9c..00000000 --- a/Grid/qcd/action/fermion/instantiation/ZWilsonImplF/CayleyFermion5DInstantiationZWilsonImplF.cc +++ /dev/null @@ -1,44 +0,0 @@ -/************************************************************************************* - -Grid physics library, www.github.com/paboyle/Grid - -Source file: ./lib/qcd/action/fermion/WilsonKernels.cc - -Copyright (C) 2015 - -Author: Peter Boyle -Author: Peter Boyle -Author: paboyle - -This program is free software; you can redistribute it and/or modify -it under the terms of the GNU General Public License as published by -the Free Software Foundation; either version 2 of the License, or -(at your option) any later version. - -This program is distributed in the hope that it will be useful, -but WITHOUT ANY WARRANTY; without even the implied warranty of -MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the -GNU General Public License for more details. - -You should have received a copy of the GNU General Public License along -with this program; if not, write to the Free Software Foundation, Inc., -51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. - -See the full license in the file "LICENSE" in the top level distribution -directory -*************************************************************************************/ -/* END LEGAL */ -#include -#include -#include - - //#include - //#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class CayleyFermion5D; - -NAMESPACE_END(Grid); - diff --git a/Grid/qcd/action/fermion/instantiation/ZWilsonImplF/CayleyFermion5DInstantiationZWilsonImplF.cc b/Grid/qcd/action/fermion/instantiation/ZWilsonImplF/CayleyFermion5DInstantiationZWilsonImplF.cc new file mode 120000 index 00000000..cb1db625 --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/ZWilsonImplF/CayleyFermion5DInstantiationZWilsonImplF.cc @@ -0,0 +1 @@ +../CayleyFermion5DInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/ZWilsonImplF/ContinuedFractionFermion5DInstantiationZWilsonImplF.cc b/Grid/qcd/action/fermion/instantiation/ZWilsonImplF/ContinuedFractionFermion5DInstantiationZWilsonImplF.cc deleted file mode 100644 index ca0d6cea..00000000 --- a/Grid/qcd/action/fermion/instantiation/ZWilsonImplF/ContinuedFractionFermion5DInstantiationZWilsonImplF.cc +++ /dev/null @@ -1,38 +0,0 @@ -/************************************************************************************* - - Grid physics library, www.github.com/paboyle/Grid - - Source file: ./lib/qcd/action/fermion/ContinuedFractionFermion5D.cc - - Copyright (C) 2015 - -Author: Peter Boyle -Author: Peter Boyle - - This program is free software; you can redistribute it and/or modify - it under the terms of the GNU General Public License as published by - the Free Software Foundation; either version 2 of the License, or - (at your option) any later version. - - This program is distributed in the hope that it will be useful, - but WITHOUT ANY WARRANTY; without even the implied warranty of - MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the - GNU General Public License for more details. - - You should have received a copy of the GNU General Public License along - with this program; if not, write to the Free Software Foundation, Inc., - 51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. - - See the full license in the file "LICENSE" in the top level distribution directory -*************************************************************************************/ -/* END LEGAL */ -#include -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class ContinuedFractionFermion5D; - -NAMESPACE_END(Grid); diff --git a/Grid/qcd/action/fermion/instantiation/ZWilsonImplF/ContinuedFractionFermion5DInstantiationZWilsonImplF.cc b/Grid/qcd/action/fermion/instantiation/ZWilsonImplF/ContinuedFractionFermion5DInstantiationZWilsonImplF.cc new file mode 120000 index 00000000..c2d4b8fc --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/ZWilsonImplF/ContinuedFractionFermion5DInstantiationZWilsonImplF.cc @@ -0,0 +1 @@ +../ContinuedFractionFermion5DInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/ZWilsonImplF/DomainWallEOFAFermionInstantiationZWilsonImplF.cc b/Grid/qcd/action/fermion/instantiation/ZWilsonImplF/DomainWallEOFAFermionInstantiationZWilsonImplF.cc deleted file mode 100644 index f7198131..00000000 --- a/Grid/qcd/action/fermion/instantiation/ZWilsonImplF/DomainWallEOFAFermionInstantiationZWilsonImplF.cc +++ /dev/null @@ -1,44 +0,0 @@ -/************************************************************************************* - -Grid physics library, www.github.com/paboyle/Grid - -Source file: ./lib/qcd/action/fermion/DomainWallEOFAFermion.cc - -Copyright (C) 2017 - -Author: Peter Boyle -Author: Peter Boyle -Author: Peter Boyle -Author: paboyle -Author: David Murphy - -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 -#include -#include -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class DomainWallEOFAFermion; - -NAMESPACE_END(Grid); diff --git a/Grid/qcd/action/fermion/instantiation/ZWilsonImplF/DomainWallEOFAFermionInstantiationZWilsonImplF.cc b/Grid/qcd/action/fermion/instantiation/ZWilsonImplF/DomainWallEOFAFermionInstantiationZWilsonImplF.cc new file mode 120000 index 00000000..2f550a2b --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/ZWilsonImplF/DomainWallEOFAFermionInstantiationZWilsonImplF.cc @@ -0,0 +1 @@ +../DomainWallEOFAFermionInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/ZWilsonImplF/MobiusEOFAFermionInstantiationZWilsonImplF.cc b/Grid/qcd/action/fermion/instantiation/ZWilsonImplF/MobiusEOFAFermionInstantiationZWilsonImplF.cc deleted file mode 100644 index ce7eaac9..00000000 --- a/Grid/qcd/action/fermion/instantiation/ZWilsonImplF/MobiusEOFAFermionInstantiationZWilsonImplF.cc +++ /dev/null @@ -1,44 +0,0 @@ -/************************************************************************************* - -Grid physics library, www.github.com/paboyle/Grid - -Source file: ./lib/qcd/action/fermion/MobiusEOFAFermion.cc - -Copyright (C) 2017 - -Author: Peter Boyle -Author: Peter Boyle -Author: Peter Boyle -Author: paboyle -Author: David Murphy - -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 -#include -#include -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class MobiusEOFAFermion; - -NAMESPACE_END(Grid); diff --git a/Grid/qcd/action/fermion/instantiation/ZWilsonImplF/MobiusEOFAFermionInstantiationZWilsonImplF.cc b/Grid/qcd/action/fermion/instantiation/ZWilsonImplF/MobiusEOFAFermionInstantiationZWilsonImplF.cc new file mode 120000 index 00000000..7a8f1172 --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/ZWilsonImplF/MobiusEOFAFermionInstantiationZWilsonImplF.cc @@ -0,0 +1 @@ +../MobiusEOFAFermionInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/ZWilsonImplF/PartialFractionFermion5DInstantiationZWilsonImplF.cc b/Grid/qcd/action/fermion/instantiation/ZWilsonImplF/PartialFractionFermion5DInstantiationZWilsonImplF.cc deleted file mode 100644 index 757719b6..00000000 --- a/Grid/qcd/action/fermion/instantiation/ZWilsonImplF/PartialFractionFermion5DInstantiationZWilsonImplF.cc +++ /dev/null @@ -1,39 +0,0 @@ -/************************************************************************************* - - Grid physics library, www.github.com/paboyle/Grid - - Source file: ./lib/qcd/action/fermion/PartialFractionFermion5D.cc - - Copyright (C) 2015 - -Author: Peter Boyle -Author: Peter Boyle - - This program is free software; you can redistribute it and/or modify - it under the terms of the GNU General Public License as published by - the Free Software Foundation; either version 2 of the License, or - (at your option) any later version. - - This program is distributed in the hope that it will be useful, - but WITHOUT ANY WARRANTY; without even the implied warranty of - MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the - GNU General Public License for more details. - - You should have received a copy of the GNU General Public License along - with this program; if not, write to the Free Software Foundation, Inc., - 51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. - - See the full license in the file "LICENSE" in the top level distribution directory -*************************************************************************************/ -/* END LEGAL */ -#include -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class PartialFractionFermion5D; - -NAMESPACE_END(Grid); - diff --git a/Grid/qcd/action/fermion/instantiation/ZWilsonImplF/PartialFractionFermion5DInstantiationZWilsonImplF.cc b/Grid/qcd/action/fermion/instantiation/ZWilsonImplF/PartialFractionFermion5DInstantiationZWilsonImplF.cc new file mode 120000 index 00000000..7f4cea71 --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/ZWilsonImplF/PartialFractionFermion5DInstantiationZWilsonImplF.cc @@ -0,0 +1 @@ +../PartialFractionFermion5DInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/ZWilsonImplF/WilsonFermion5DInstantiationZWilsonImplF.cc b/Grid/qcd/action/fermion/instantiation/ZWilsonImplF/WilsonFermion5DInstantiationZWilsonImplF.cc deleted file mode 100644 index 0dac989c..00000000 --- a/Grid/qcd/action/fermion/instantiation/ZWilsonImplF/WilsonFermion5DInstantiationZWilsonImplF.cc +++ /dev/null @@ -1,40 +0,0 @@ -/************************************************************************************* - -Grid physics library, www.github.com/paboyle/Grid - -Source file: ./lib/qcd/action/fermion/WilsonKernels.cc - -Copyright (C) 2015 - -Author: Peter Boyle -Author: Peter Boyle -Author: paboyle - -This program is free software; you can redistribute it and/or modify -it under the terms of the GNU General Public License as published by -the Free Software Foundation; either version 2 of the License, or -(at your option) any later version. - -This program is distributed in the hope that it will be useful, -but WITHOUT ANY WARRANTY; without even the implied warranty of -MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the -GNU General Public License for more details. - -You should have received a copy of the GNU General Public License along -with this program; if not, write to the Free Software Foundation, Inc., -51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. - -See the full license in the file "LICENSE" in the top level distribution -directory -*************************************************************************************/ -/* END LEGAL */ -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class WilsonFermion5D; - -NAMESPACE_END(Grid); - diff --git a/Grid/qcd/action/fermion/instantiation/ZWilsonImplF/WilsonFermion5DInstantiationZWilsonImplF.cc b/Grid/qcd/action/fermion/instantiation/ZWilsonImplF/WilsonFermion5DInstantiationZWilsonImplF.cc new file mode 120000 index 00000000..804d0884 --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/ZWilsonImplF/WilsonFermion5DInstantiationZWilsonImplF.cc @@ -0,0 +1 @@ +../WilsonFermion5DInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/ZWilsonImplF/WilsonKernelsInstantiationZWilsonImplF.cc b/Grid/qcd/action/fermion/instantiation/ZWilsonImplF/WilsonKernelsInstantiationZWilsonImplF.cc deleted file mode 100644 index 9af5ed85..00000000 --- a/Grid/qcd/action/fermion/instantiation/ZWilsonImplF/WilsonKernelsInstantiationZWilsonImplF.cc +++ /dev/null @@ -1,47 +0,0 @@ -/************************************************************************************* - -Grid physics library, www.github.com/paboyle/Grid - -Source file: ./lib/qcd/action/fermion/WilsonKernels.cc - -Copyright (C) 2015 - -Author: Peter Boyle -Author: Peter Boyle -Author: paboyle - -This program is free software; you can redistribute it and/or modify -it under the terms of the GNU General Public License as published by -the Free Software Foundation; either version 2 of the License, or -(at your option) any later version. - -This program is distributed in the hope that it will be useful, -but WITHOUT ANY WARRANTY; without even the implied warranty of -MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the -GNU General Public License for more details. - -You should have received a copy of the GNU General Public License along -with this program; if not, write to the Free Software Foundation, Inc., -51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. - -See the full license in the file "LICENSE" in the top level distribution -directory -*************************************************************************************/ -/* END LEGAL */ -#include -#include -#include - -#ifndef AVX512 -#ifndef QPX -#include -#endif -#endif - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class WilsonKernels; - -NAMESPACE_END(Grid); - diff --git a/Grid/qcd/action/fermion/instantiation/ZWilsonImplF/WilsonKernelsInstantiationZWilsonImplF.cc b/Grid/qcd/action/fermion/instantiation/ZWilsonImplF/WilsonKernelsInstantiationZWilsonImplF.cc new file mode 120000 index 00000000..01c35e7b --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/ZWilsonImplF/WilsonKernelsInstantiationZWilsonImplF.cc @@ -0,0 +1 @@ +../WilsonKernelsInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/ZWilsonImplFH/CayleyFermion5DInstantiationZWilsonImplFH.cc b/Grid/qcd/action/fermion/instantiation/ZWilsonImplFH/CayleyFermion5DInstantiationZWilsonImplFH.cc deleted file mode 100644 index 5130db9c..00000000 --- a/Grid/qcd/action/fermion/instantiation/ZWilsonImplFH/CayleyFermion5DInstantiationZWilsonImplFH.cc +++ /dev/null @@ -1,44 +0,0 @@ -/************************************************************************************* - -Grid physics library, www.github.com/paboyle/Grid - -Source file: ./lib/qcd/action/fermion/WilsonKernels.cc - -Copyright (C) 2015 - -Author: Peter Boyle -Author: Peter Boyle -Author: paboyle - -This program is free software; you can redistribute it and/or modify -it under the terms of the GNU General Public License as published by -the Free Software Foundation; either version 2 of the License, or -(at your option) any later version. - -This program is distributed in the hope that it will be useful, -but WITHOUT ANY WARRANTY; without even the implied warranty of -MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the -GNU General Public License for more details. - -You should have received a copy of the GNU General Public License along -with this program; if not, write to the Free Software Foundation, Inc., -51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. - -See the full license in the file "LICENSE" in the top level distribution -directory -*************************************************************************************/ -/* END LEGAL */ -#include -#include -#include - - //#include - //#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class CayleyFermion5D; - -NAMESPACE_END(Grid); - diff --git a/Grid/qcd/action/fermion/instantiation/ZWilsonImplFH/CayleyFermion5DInstantiationZWilsonImplFH.cc b/Grid/qcd/action/fermion/instantiation/ZWilsonImplFH/CayleyFermion5DInstantiationZWilsonImplFH.cc new file mode 120000 index 00000000..cb1db625 --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/ZWilsonImplFH/CayleyFermion5DInstantiationZWilsonImplFH.cc @@ -0,0 +1 @@ +../CayleyFermion5DInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/ZWilsonImplFH/ContinuedFractionFermion5DInstantiationZWilsonImplFH.cc b/Grid/qcd/action/fermion/instantiation/ZWilsonImplFH/ContinuedFractionFermion5DInstantiationZWilsonImplFH.cc deleted file mode 100644 index ca0d6cea..00000000 --- a/Grid/qcd/action/fermion/instantiation/ZWilsonImplFH/ContinuedFractionFermion5DInstantiationZWilsonImplFH.cc +++ /dev/null @@ -1,38 +0,0 @@ -/************************************************************************************* - - Grid physics library, www.github.com/paboyle/Grid - - Source file: ./lib/qcd/action/fermion/ContinuedFractionFermion5D.cc - - Copyright (C) 2015 - -Author: Peter Boyle -Author: Peter Boyle - - This program is free software; you can redistribute it and/or modify - it under the terms of the GNU General Public License as published by - the Free Software Foundation; either version 2 of the License, or - (at your option) any later version. - - This program is distributed in the hope that it will be useful, - but WITHOUT ANY WARRANTY; without even the implied warranty of - MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the - GNU General Public License for more details. - - You should have received a copy of the GNU General Public License along - with this program; if not, write to the Free Software Foundation, Inc., - 51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. - - See the full license in the file "LICENSE" in the top level distribution directory -*************************************************************************************/ -/* END LEGAL */ -#include -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class ContinuedFractionFermion5D; - -NAMESPACE_END(Grid); diff --git a/Grid/qcd/action/fermion/instantiation/ZWilsonImplFH/ContinuedFractionFermion5DInstantiationZWilsonImplFH.cc b/Grid/qcd/action/fermion/instantiation/ZWilsonImplFH/ContinuedFractionFermion5DInstantiationZWilsonImplFH.cc new file mode 120000 index 00000000..c2d4b8fc --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/ZWilsonImplFH/ContinuedFractionFermion5DInstantiationZWilsonImplFH.cc @@ -0,0 +1 @@ +../ContinuedFractionFermion5DInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/ZWilsonImplFH/DomainWallEOFAFermionInstantiationZWilsonImplFH.cc b/Grid/qcd/action/fermion/instantiation/ZWilsonImplFH/DomainWallEOFAFermionInstantiationZWilsonImplFH.cc deleted file mode 100644 index f7198131..00000000 --- a/Grid/qcd/action/fermion/instantiation/ZWilsonImplFH/DomainWallEOFAFermionInstantiationZWilsonImplFH.cc +++ /dev/null @@ -1,44 +0,0 @@ -/************************************************************************************* - -Grid physics library, www.github.com/paboyle/Grid - -Source file: ./lib/qcd/action/fermion/DomainWallEOFAFermion.cc - -Copyright (C) 2017 - -Author: Peter Boyle -Author: Peter Boyle -Author: Peter Boyle -Author: paboyle -Author: David Murphy - -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 -#include -#include -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class DomainWallEOFAFermion; - -NAMESPACE_END(Grid); diff --git a/Grid/qcd/action/fermion/instantiation/ZWilsonImplFH/DomainWallEOFAFermionInstantiationZWilsonImplFH.cc b/Grid/qcd/action/fermion/instantiation/ZWilsonImplFH/DomainWallEOFAFermionInstantiationZWilsonImplFH.cc new file mode 120000 index 00000000..2f550a2b --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/ZWilsonImplFH/DomainWallEOFAFermionInstantiationZWilsonImplFH.cc @@ -0,0 +1 @@ +../DomainWallEOFAFermionInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/ZWilsonImplFH/MobiusEOFAFermionInstantiationZWilsonImplFH.cc b/Grid/qcd/action/fermion/instantiation/ZWilsonImplFH/MobiusEOFAFermionInstantiationZWilsonImplFH.cc deleted file mode 100644 index ce7eaac9..00000000 --- a/Grid/qcd/action/fermion/instantiation/ZWilsonImplFH/MobiusEOFAFermionInstantiationZWilsonImplFH.cc +++ /dev/null @@ -1,44 +0,0 @@ -/************************************************************************************* - -Grid physics library, www.github.com/paboyle/Grid - -Source file: ./lib/qcd/action/fermion/MobiusEOFAFermion.cc - -Copyright (C) 2017 - -Author: Peter Boyle -Author: Peter Boyle -Author: Peter Boyle -Author: paboyle -Author: David Murphy - -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 -#include -#include -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class MobiusEOFAFermion; - -NAMESPACE_END(Grid); diff --git a/Grid/qcd/action/fermion/instantiation/ZWilsonImplFH/MobiusEOFAFermionInstantiationZWilsonImplFH.cc b/Grid/qcd/action/fermion/instantiation/ZWilsonImplFH/MobiusEOFAFermionInstantiationZWilsonImplFH.cc new file mode 120000 index 00000000..7a8f1172 --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/ZWilsonImplFH/MobiusEOFAFermionInstantiationZWilsonImplFH.cc @@ -0,0 +1 @@ +../MobiusEOFAFermionInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/ZWilsonImplFH/PartialFractionFermion5DInstantiationZWilsonImplFH.cc b/Grid/qcd/action/fermion/instantiation/ZWilsonImplFH/PartialFractionFermion5DInstantiationZWilsonImplFH.cc deleted file mode 100644 index 757719b6..00000000 --- a/Grid/qcd/action/fermion/instantiation/ZWilsonImplFH/PartialFractionFermion5DInstantiationZWilsonImplFH.cc +++ /dev/null @@ -1,39 +0,0 @@ -/************************************************************************************* - - Grid physics library, www.github.com/paboyle/Grid - - Source file: ./lib/qcd/action/fermion/PartialFractionFermion5D.cc - - Copyright (C) 2015 - -Author: Peter Boyle -Author: Peter Boyle - - This program is free software; you can redistribute it and/or modify - it under the terms of the GNU General Public License as published by - the Free Software Foundation; either version 2 of the License, or - (at your option) any later version. - - This program is distributed in the hope that it will be useful, - but WITHOUT ANY WARRANTY; without even the implied warranty of - MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the - GNU General Public License for more details. - - You should have received a copy of the GNU General Public License along - with this program; if not, write to the Free Software Foundation, Inc., - 51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. - - See the full license in the file "LICENSE" in the top level distribution directory -*************************************************************************************/ -/* END LEGAL */ -#include -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class PartialFractionFermion5D; - -NAMESPACE_END(Grid); - diff --git a/Grid/qcd/action/fermion/instantiation/ZWilsonImplFH/PartialFractionFermion5DInstantiationZWilsonImplFH.cc b/Grid/qcd/action/fermion/instantiation/ZWilsonImplFH/PartialFractionFermion5DInstantiationZWilsonImplFH.cc new file mode 120000 index 00000000..7f4cea71 --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/ZWilsonImplFH/PartialFractionFermion5DInstantiationZWilsonImplFH.cc @@ -0,0 +1 @@ +../PartialFractionFermion5DInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/ZWilsonImplFH/WilsonFermion5DInstantiationZWilsonImplFH.cc b/Grid/qcd/action/fermion/instantiation/ZWilsonImplFH/WilsonFermion5DInstantiationZWilsonImplFH.cc deleted file mode 100644 index 0dac989c..00000000 --- a/Grid/qcd/action/fermion/instantiation/ZWilsonImplFH/WilsonFermion5DInstantiationZWilsonImplFH.cc +++ /dev/null @@ -1,40 +0,0 @@ -/************************************************************************************* - -Grid physics library, www.github.com/paboyle/Grid - -Source file: ./lib/qcd/action/fermion/WilsonKernels.cc - -Copyright (C) 2015 - -Author: Peter Boyle -Author: Peter Boyle -Author: paboyle - -This program is free software; you can redistribute it and/or modify -it under the terms of the GNU General Public License as published by -the Free Software Foundation; either version 2 of the License, or -(at your option) any later version. - -This program is distributed in the hope that it will be useful, -but WITHOUT ANY WARRANTY; without even the implied warranty of -MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the -GNU General Public License for more details. - -You should have received a copy of the GNU General Public License along -with this program; if not, write to the Free Software Foundation, Inc., -51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. - -See the full license in the file "LICENSE" in the top level distribution -directory -*************************************************************************************/ -/* END LEGAL */ -#include -#include - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class WilsonFermion5D; - -NAMESPACE_END(Grid); - diff --git a/Grid/qcd/action/fermion/instantiation/ZWilsonImplFH/WilsonFermion5DInstantiationZWilsonImplFH.cc b/Grid/qcd/action/fermion/instantiation/ZWilsonImplFH/WilsonFermion5DInstantiationZWilsonImplFH.cc new file mode 120000 index 00000000..804d0884 --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/ZWilsonImplFH/WilsonFermion5DInstantiationZWilsonImplFH.cc @@ -0,0 +1 @@ +../WilsonFermion5DInstantiation.cc.master \ No newline at end of file diff --git a/Grid/qcd/action/fermion/instantiation/ZWilsonImplFH/WilsonKernelsInstantiationZWilsonImplFH.cc b/Grid/qcd/action/fermion/instantiation/ZWilsonImplFH/WilsonKernelsInstantiationZWilsonImplFH.cc deleted file mode 100644 index 9af5ed85..00000000 --- a/Grid/qcd/action/fermion/instantiation/ZWilsonImplFH/WilsonKernelsInstantiationZWilsonImplFH.cc +++ /dev/null @@ -1,47 +0,0 @@ -/************************************************************************************* - -Grid physics library, www.github.com/paboyle/Grid - -Source file: ./lib/qcd/action/fermion/WilsonKernels.cc - -Copyright (C) 2015 - -Author: Peter Boyle -Author: Peter Boyle -Author: paboyle - -This program is free software; you can redistribute it and/or modify -it under the terms of the GNU General Public License as published by -the Free Software Foundation; either version 2 of the License, or -(at your option) any later version. - -This program is distributed in the hope that it will be useful, -but WITHOUT ANY WARRANTY; without even the implied warranty of -MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the -GNU General Public License for more details. - -You should have received a copy of the GNU General Public License along -with this program; if not, write to the Free Software Foundation, Inc., -51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. - -See the full license in the file "LICENSE" in the top level distribution -directory -*************************************************************************************/ -/* END LEGAL */ -#include -#include -#include - -#ifndef AVX512 -#ifndef QPX -#include -#endif -#endif - -NAMESPACE_BEGIN(Grid); - -#include "impl.h" -template class WilsonKernels; - -NAMESPACE_END(Grid); - diff --git a/Grid/qcd/action/fermion/instantiation/ZWilsonImplFH/WilsonKernelsInstantiationZWilsonImplFH.cc b/Grid/qcd/action/fermion/instantiation/ZWilsonImplFH/WilsonKernelsInstantiationZWilsonImplFH.cc new file mode 120000 index 00000000..01c35e7b --- /dev/null +++ b/Grid/qcd/action/fermion/instantiation/ZWilsonImplFH/WilsonKernelsInstantiationZWilsonImplFH.cc @@ -0,0 +1 @@ +../WilsonKernelsInstantiation.cc.master \ No newline at end of file diff --git a/Hadrons/Modules/MSource/SeqConserved.hpp b/Hadrons/Modules/MSource/SeqConserved.hpp index c8d5121d..2de50ac2 100644 --- a/Hadrons/Modules/MSource/SeqConserved.hpp +++ b/Hadrons/Modules/MSource/SeqConserved.hpp @@ -176,6 +176,7 @@ void TSeqConserved::execute(void) envGetTmp(LatticeComplex, latt_compl); src = Zero(); + auto zz = src; //exp(ipx) auto &mom_phase = envGet(LatticeComplex, SeqmomphName_); @@ -215,8 +216,8 @@ void TSeqConserved::execute(void) latt_compl = mom_phase; } - mat.SeqConservedCurrent(q, src_tmp, par().curr_type, mu, - par().tA, par().tB, latt_compl); + mat.SeqConservedCurrent(q, src_tmp, zz, par().curr_type, mu, + par().tA, par().tB, latt_compl); src += src_tmp; } From e96c86ec146c73e0386f3348cae6c0bf6e8ae094 Mon Sep 17 00:00:00 2001 From: Michael Marshall <43034299+mmphys@users.noreply.github.com> Date: Thu, 23 Apr 2020 13:10:45 +0100 Subject: [PATCH 12/36] Make grid-config message more specific for --cxx and --cxxld --- grid-config.in | 4 ++-- 1 file changed, 2 insertions(+), 2 deletions(-) diff --git a/grid-config.in b/grid-config.in index 5de53aa7..a12c9fdb 100755 --- a/grid-config.in +++ b/grid-config.in @@ -19,8 +19,8 @@ Known values for OPTION are: --help display this help and exit --version output version information --git print git revision - --cxx print c++ compiler and compiler flags - --cxxld print c++ linker and linker flags + --cxx print c++ compiler (may include some flags and spaces) + --cxxld print c++ linker (may include some flags and spaces) EOF From 5daf176f4a55c144368a7229dacbc055a76ed9f0 Mon Sep 17 00:00:00 2001 From: Michael Marshall <43034299+mmphys@users.noreply.github.com> Date: Thu, 23 Apr 2020 15:25:53 +0100 Subject: [PATCH 13/36] Updated to expose GRID_CXXLD in addition to CXXLD. NB: CXXLD required as this is what drives linking behaviour. --- configure.ac | 2 ++ grid-config.in | 2 +- 2 files changed, 3 insertions(+), 1 deletion(-) diff --git a/configure.ac b/configure.ac index 3d4ee383..fb69ca0e 100644 --- a/configure.ac +++ b/configure.ac @@ -547,6 +547,7 @@ DX_INIT_DOXYGEN([$PACKAGE_NAME], [doxygen.cfg]) ############### Ouput cwd=`pwd -P`; cd ${srcdir}; abs_srcdir=`pwd -P`; cd ${cwd} GRID_CXX="$CXX" +GRID_CXXLD="$CXXLD" GRID_CXXFLAGS="$AM_CXXFLAGS $CXXFLAGS" GRID_LDFLAGS="$AM_LDFLAGS $LDFLAGS" GRID_LIBS=$LIBS @@ -561,6 +562,7 @@ AC_SUBST([AM_CFLAGS]) AC_SUBST([AM_CXXFLAGS]) AC_SUBST([AM_LDFLAGS]) AC_SUBST([GRID_CXX]) +AC_SUBST([GRID_CXXLD]) AC_SUBST([GRID_CXXFLAGS]) AC_SUBST([GRID_LDFLAGS]) AC_SUBST([GRID_LIBS]) diff --git a/grid-config.in b/grid-config.in index a12c9fdb..af0816a5 100755 --- a/grid-config.in +++ b/grid-config.in @@ -68,7 +68,7 @@ while test $# -gt 0; do ;; --cxxld) - echo @CXXLD@ + echo @GRID_CXXLD@ ;; --ldflags) From f1fe444d4fa205896f1d3c3b37c44567086a3b96 Mon Sep 17 00:00:00 2001 From: Christoph Lehner Date: Fri, 24 Apr 2020 06:27:20 -0400 Subject: [PATCH 14/36] blocked precision promotion infrastructure upgrade --- Grid/tensors/Tensor_inner.h | 1 + Grid/tensors/Tensor_traits.h | 24 +++++++++++++++++++++--- tests/Test_innerproduct_norm.cc | 4 ++-- 3 files changed, 24 insertions(+), 5 deletions(-) diff --git a/Grid/tensors/Tensor_inner.h b/Grid/tensors/Tensor_inner.h index c052adcf..fd651cae 100644 --- a/Grid/tensors/Tensor_inner.h +++ b/Grid/tensors/Tensor_inner.h @@ -200,6 +200,7 @@ auto innerProductD (const iScalar& lhs,const iScalar& rhs) -> iScalar struct isGridTensor> : public std::true_type { static constexpr bool notvalue = false; }; template struct isGridTensor> : public std::true_type { static constexpr bool notvalue = false; }; - // To store double-precision data in single-precision grids for precision promoted localInnerProductD + // Traits to identify scalars + template struct isGridScalar : public std::false_type { static constexpr bool notvalue = true; }; + template struct isGridScalar> : public std::true_type { static constexpr bool notvalue = false; }; + + // Store double-precision data in single-precision grids for precision promoted localInnerProductD + typedef iVector ComplexD2; typedef iVector vComplexD2; + typedef iVector RealD2; typedef iVector vRealD2; + // Traits to identify fundamental data types + template struct isGridFundamental : public std::false_type { static constexpr bool notvalue = true; }; + template<> struct isGridFundamental : public std::true_type { static constexpr bool notvalue = false; }; + template<> struct isGridFundamental : public std::true_type { static constexpr bool notvalue = false; }; + template<> struct isGridFundamental : public std::true_type { static constexpr bool notvalue = false; }; + template<> struct isGridFundamental : public std::true_type { static constexpr bool notvalue = false; }; + template<> struct isGridFundamental : public std::true_type { static constexpr bool notvalue = false; }; + template<> struct isGridFundamental : public std::true_type { static constexpr bool notvalue = false; }; + template<> struct isGridFundamental : public std::true_type { static constexpr bool notvalue = false; }; + template<> struct isGridFundamental : public std::true_type { static constexpr bool notvalue = false; }; + + ////////////////////////////////////////////////////////////////////////////////// // Want to recurse: GridTypeMapper >::scalar_type == ComplexD. // Use of a helper class like this allows us to template specialise and "dress" @@ -86,7 +104,7 @@ NAMESPACE_BEGIN(Grid); typedef ComplexF Complexified; typedef RealF Realified; typedef RealD DoublePrecision; - typedef RealD DoublePrecision2; + typedef RealD2 DoublePrecision2; }; template<> struct GridTypeMapper : public GridTypeMapper_Base { typedef RealD scalar_type; @@ -112,7 +130,7 @@ NAMESPACE_BEGIN(Grid); typedef ComplexF Complexified; typedef RealF Realified; typedef ComplexD DoublePrecision; - typedef ComplexD DoublePrecision2; + typedef ComplexD2 DoublePrecision2; }; template<> struct GridTypeMapper : public GridTypeMapper_Base { typedef ComplexD scalar_type; diff --git a/tests/Test_innerproduct_norm.cc b/tests/Test_innerproduct_norm.cc index 85c98521..a8718c6b 100644 --- a/tests/Test_innerproduct_norm.cc +++ b/tests/Test_innerproduct_norm.cc @@ -72,7 +72,7 @@ int main(int argc, char** argv) { sw_res.Reset(); sw_res.Start(); - for(int i = 0; i < nIter; ++i) { innerProduct_norm(ip_d_res, norm2_d_res, x_d, y_d); } + for(int i = 0; i < nIter; ++i) { innerProductNorm(ip_d_res, norm2_d_res, x_d, y_d); } sw_res.Stop(); diff_ip_d = ip_d_ref - ip_d_res; @@ -104,7 +104,7 @@ int main(int argc, char** argv) { sw_res.Reset(); sw_res.Start(); - for(int i = 0; i < nIter; ++i) { innerProduct_norm(ip_f_res, norm2_f_res, x_f, y_f); } + for(int i = 0; i < nIter; ++i) { innerProductNorm(ip_f_res, norm2_f_res, x_f, y_f); } sw_res.Stop(); diff_ip_f = ip_f_ref - ip_f_res; From 29ae5615c0e5c080061e2176bbd5c3f6a61c0b0b Mon Sep 17 00:00:00 2001 From: Peter Boyle Date: Wed, 29 Apr 2020 03:05:15 -0400 Subject: [PATCH 15/36] Seqeuential fix --- tests/debug/Test_cayley_mres.cc | 104 ++++++++++++++++++++------------ 1 file changed, 66 insertions(+), 38 deletions(-) diff --git a/tests/debug/Test_cayley_mres.cc b/tests/debug/Test_cayley_mres.cc index 0562546c..1bf6f2dc 100644 --- a/tests/debug/Test_cayley_mres.cc +++ b/tests/debug/Test_cayley_mres.cc @@ -57,18 +57,34 @@ int main (int argc, char ** argv) std::cout< omegas(10,ComplexD(1.0,0.0)); - std::vector < ComplexD > omegasrev(10,ComplexD(1.0,0.0)); - omegas.push_back( std::complex(0.0686324988446592,0.0550658530827402) ); - omegas.push_back( std::complex(0.0686324988446592,-0.0550658530827402) ); + std::vector < ComplexD > omegas; + std::vector < ComplexD > omegasrev(Ls); + +#if 1 omegas.push_back( std::complex(1.45806438985048,-0) ); omegas.push_back( std::complex(0.830951166685955,-0) ); omegas.push_back( std::complex(0.341985020453729,-0) ); omegas.push_back( std::complex(0.126074299502912,-0) ); + // omegas.push_back( std::complex(0.0686324988446592,0.0550658530827402) ); + // omegas.push_back( std::complex(0.0686324988446592,-0.0550658530827402) ); + omegas.push_back( std::complex(0.0686324988446592,0)); + omegas.push_back( std::complex(0.0686324988446592,0)); omegas.push_back( std::complex(0.0990136651962626,-0) ); omegas.push_back( std::complex(0.21137902619029,-0) ); omegas.push_back( std::complex(0.542352409156791,-0) ); omegas.push_back( std::complex(1.18231318389348,-0) ); +#else + omegas.push_back( std::complex(0.8,0.0)); + omegas.push_back( std::complex(1.1,0.0)); + omegas.push_back( std::complex(1.2,0.0)); + omegas.push_back( std::complex(1.3,0.0)); + omegas.push_back( std::complex(0.5,0.2)); + omegas.push_back( std::complex(0.5,-0.2)); + omegas.push_back( std::complex(0.8,0.0)); + omegas.push_back( std::complex(1.1,0.0)); + omegas.push_back( std::complex(1.2,0.0)); + omegas.push_back( std::complex(1.3,0.0)); +#endif GridCartesian * UGrid = SpaceTimeGrid::makeFourDimGrid(GridDefaultLatt(), GridDefaultSimd(Nd,vComplex::Nsimd()), @@ -92,10 +108,10 @@ int main (int argc, char ** argv) GridParallelRNG RNG4(UGrid); RNG4.SeedFixedIntegers(seeds4); LatticeGaugeField Umu(UGrid); - // SU3::ColdConfiguration(Umu); - SU3::HotConfiguration(RNG4,Umu); + SU3::ColdConfiguration(Umu); + // SU3::HotConfiguration(RNG4,Umu); - RealD mass=0.2; + RealD mass=0.3; RealD M5 =1.0; std::cout< gamma(Ls,ComplexD(1.0,0.0)); + // std::vector gamma(Ls,ComplexD(1.0,0.0)); std::cout<(Dsham,Dsham,Umu,FGrid,FrbGrid,UGrid,UrbGrid,mass,M5,&RNG4,&RNG5); - std::cout< -void TestConserved(Action & Ddwf, Action & Ddwfrev, - LatticeGaugeField &Umu, - GridCartesian * FGrid, GridRedBlackCartesian * FrbGrid, - GridCartesian * UGrid, GridRedBlackCartesian * UrbGrid, - RealD mass, RealD M5, - GridParallelRNG *RNG4, - GridParallelRNG *RNG5) +void TestConserved(Action & Ddwf, + Action & Ddwfrev, + LatticeGaugeField &Umu, + GridCartesian * FGrid, GridRedBlackCartesian * FrbGrid, + GridCartesian * UGrid, GridRedBlackCartesian * UrbGrid, + RealD mass, RealD M5, + GridParallelRNG *RNG4, + GridParallelRNG *RNG5) { int Ls=Ddwf.Ls; @@ -155,7 +171,10 @@ void TestConserved(Action & Ddwf, Action & Ddwfrev, LatticePropagator prop5rev(FGrid); LatticePropagator prop4(UGrid); LatticePropagator Axial_mu(UGrid); + LatticePropagator Vector_mu(UGrid); LatticeComplex PA (UGrid); + LatticeComplex SV (UGrid); + LatticeComplex VV (UGrid); LatticeComplex PJ5q(UGrid); LatticeComplex PP (UGrid); LatticePropagator seqprop(UGrid); @@ -167,7 +186,7 @@ void TestConserved(Action & Ddwf, Action & Ddwfrev, MdagMLinearOperator HermOp(Ddwf); MdagMLinearOperator HermOprev(Ddwfrev); - ConjugateGradient CG(1.0e-12,10000); + ConjugateGradient CG(1.0e-16,100000); for(int s=0;s(prop4,result4,s,c); + Ddwfrev.ImportPhysicalFermionSource(src4,src5); Ddwfrev.Mdag(src5,Mdagsrc5); CG(HermOprev,Mdagsrc5,result5); FermToProp(prop5rev,result5,s,c); } } - #if 1 auto curr = Current::Axial; const int mu_J=Nd-1; @@ -206,14 +225,14 @@ void TestConserved(Action & Ddwf, Action & Ddwfrev, LatticeComplex ph (UGrid); ph=1.0; - Ddwfrev.SeqConservedCurrent(prop5rev, - seqsrc, - phys_src, - curr, - mu_J, - t_J, - t_J,// whole lattice - ph); + Ddwf.SeqConservedCurrent(prop5, + seqsrc, + phys_src, + curr, + mu_J, + t_J, + t_J,// whole lattice + ph); for(int s=0;s sumPA; + std::vector sumSV; + std::vector sumVV; std::vector sumPP; std::vector sumPJ5q; - Ddwf.ContractConservedCurrent(prop5rev,prop5,Axial_mu,phys_src,Current::Axial,Tdir); - //Ddwf.ContractConservedCurrent(prop5rev,prop5,Axial_mu,Current::Axial,Tdir); + Ddwf.ContractConservedCurrent(prop5rev,prop5,Vector_mu,phys_src,Current::Vector,Tdir); Ddwf.ContractJ5q(prop5,PJ5q); PA = trace(g5*Axial_mu); + SV = trace(Vector_mu); + VV = trace(gT*Vector_mu); PP = trace(adj(prop4)*prop4); // Spatial sum sliceSum(PA,sumPA,Tdir); + sliceSum(SV,sumSV,Tdir); + sliceSum(VV,sumVV,Tdir); sliceSum(PP,sumPP,Tdir); sliceSum(PJ5q,sumPJ5q,Tdir); int Nt=sumPA.size(); + for(int t=0;t U(4,FGrid); { From dd3ebc2ce4478d7faf9b0bfd5dd9f89e185d20d6 Mon Sep 17 00:00:00 2001 From: Peter Boyle Date: Wed, 29 Apr 2020 08:43:12 -0400 Subject: [PATCH 16/36] Slow compile on NVCC switch off conserved current --- .../fermion/implementation/CayleyFermion5DImplementation.h | 4 +++- 1 file changed, 3 insertions(+), 1 deletion(-) diff --git a/Grid/qcd/action/fermion/implementation/CayleyFermion5DImplementation.h b/Grid/qcd/action/fermion/implementation/CayleyFermion5DImplementation.h index 9c6cdbf3..c80d2425 100644 --- a/Grid/qcd/action/fermion/implementation/CayleyFermion5DImplementation.h +++ b/Grid/qcd/action/fermion/implementation/CayleyFermion5DImplementation.h @@ -644,6 +644,7 @@ void CayleyFermion5D::ContractConservedCurrent( PropagatorField &q_in_1, Current curr_type, unsigned int mu) { +#ifndef GRID_NVCC Gamma::Algebra Gmu [] = { Gamma::Algebra::GammaX, Gamma::Algebra::GammaY, @@ -762,6 +763,7 @@ void CayleyFermion5D::ContractConservedCurrent( PropagatorField &q_in_1, else q_out += C; } +#endif } template @@ -826,7 +828,7 @@ void CayleyFermion5D::SeqConservedCurrent(PropagatorField &q_in, } #endif -#if 1 +#ifndef GRID_NVCC //////////////////////////////////////////////// // GENERAL CAYLEY CASE //////////////////////////////////////////////// From dee96cbf8296b9f16dc378c78cdcb74302da77c5 Mon Sep 17 00:00:00 2001 From: Christopher Kelly Date: Wed, 29 Apr 2020 10:37:11 -0400 Subject: [PATCH 17/36] Added workaround in configure to still catch Cuda compiler when nvcc with extra arguments (eg -ccbin) is used as CXX --- configure.ac | 14 +++++++++++--- 1 file changed, 11 insertions(+), 3 deletions(-) diff --git a/configure.ac b/configure.ac index fb69ca0e..46559507 100644 --- a/configure.ac +++ b/configure.ac @@ -274,12 +274,20 @@ case ${ac_gen_scalar} in esac ##################### Compiler dependent choices -case ${CXX} in + +#Strip any optional compiler arguments from nvcc call (eg -ccbin) for compiler comparison +CXXBASE=${CXX} +CXXTEST=${CXX} +if echo "${CXX}" | grep -q "nvcc"; then + CXXTEST="nvcc" +fi + +case ${CXXTEST} in nvcc) # CXX="nvcc -keep -v -x cu " # CXXLD="nvcc -v -link" - CXX="nvcc -x cu " - CXXLD="nvcc -link" + CXX="${CXXBASE} -x cu " + CXXLD="${CXXBASE} -link" # CXXFLAGS="$CXXFLAGS -Xcompiler -fno-strict-aliasing -Xcompiler -Wno-unusable-partial-specialization --expt-extended-lambda --expt-relaxed-constexpr" CXXFLAGS="$CXXFLAGS -Xcompiler -fno-strict-aliasing --expt-extended-lambda --expt-relaxed-constexpr" if test $ac_openmp = yes; then From dbaeefaeef334eabd3feeb73c70da13c9a548bcf Mon Sep 17 00:00:00 2001 From: Michael Marshall <43034299+mmphys@users.noreply.github.com> Date: Thu, 30 Apr 2020 15:02:51 +0100 Subject: [PATCH 18/36] All Eigen::TensorMap objects are fixed (i.e. cannot be dynamically resized) --- Grid/serialisation/BaseIO.h | 6 +----- 1 file changed, 1 insertion(+), 5 deletions(-) diff --git a/Grid/serialisation/BaseIO.h b/Grid/serialisation/BaseIO.h index bf424fc7..49406201 100644 --- a/Grid/serialisation/BaseIO.h +++ b/Grid/serialisation/BaseIO.h @@ -87,11 +87,7 @@ namespace Grid { template struct is_tensor_fixed> : public std::true_type {}; - template class MapPointer_> - struct is_tensor_fixed, MapOptions_, MapPointer_>> - : public std::true_type {}; + template struct is_tensor_fixed> : public std::true_type {}; // Is this a variable-size Eigen tensor template struct is_tensor_variable : public std::false_type {}; From 5011753f4fafad0586161de7686ad1d8c3cc3774 Mon Sep 17 00:00:00 2001 From: Peter Boyle Date: Thu, 30 Apr 2020 10:23:48 -0400 Subject: [PATCH 19/36] Clean up warning --- Grid/lattice/Lattice_peekpoke.h | 4 ++-- 1 file changed, 2 insertions(+), 2 deletions(-) diff --git a/Grid/lattice/Lattice_peekpoke.h b/Grid/lattice/Lattice_peekpoke.h index feca2f44..8f649bd7 100644 --- a/Grid/lattice/Lattice_peekpoke.h +++ b/Grid/lattice/Lattice_peekpoke.h @@ -156,7 +156,7 @@ void peekSite(sobj &s,const Lattice &l,const Coordinate &site){ // Peek a scalar object from the SIMD array ////////////////////////////////////////////////////////// template -accelerator_inline void peekLocalSite(sobj &s,const Lattice &l,Coordinate &site){ +inline void peekLocalSite(sobj &s,const Lattice &l,Coordinate &site){ GridBase *grid = l.Grid(); @@ -185,7 +185,7 @@ accelerator_inline void peekLocalSite(sobj &s,const Lattice &l,Coordinate }; template -accelerator_inline void pokeLocalSite(const sobj &s,Lattice &l,Coordinate &site){ +inline void pokeLocalSite(const sobj &s,Lattice &l,Coordinate &site){ GridBase *grid=l.Grid(); From 9b2d2d0fc3bcea50f9394badf2833b5de3ce452f Mon Sep 17 00:00:00 2001 From: Peter Boyle Date: Thu, 30 Apr 2020 12:31:07 -0400 Subject: [PATCH 20/36] Basis rotate stack passig to GPU reduction --- Grid/algorithms/iterative/ImplicitlyRestartedLanczos.h | 8 ++++---- 1 file changed, 4 insertions(+), 4 deletions(-) diff --git a/Grid/algorithms/iterative/ImplicitlyRestartedLanczos.h b/Grid/algorithms/iterative/ImplicitlyRestartedLanczos.h index 8bee43cc..a44b245c 100644 --- a/Grid/algorithms/iterative/ImplicitlyRestartedLanczos.h +++ b/Grid/algorithms/iterative/ImplicitlyRestartedLanczos.h @@ -108,7 +108,6 @@ void basisRotate(std::vector &basis,Eigen::MatrixXd& Qt,int j0, int j1, i } // Block the loop to keep storage footprint down - vobj zz=Zero(); for(uint64_t s=0;s &basis,Eigen::MatrixXd& Qt,int j0, int j1, i // zero out the accumulators accelerator_for(ss,siteBlock*nrot,vobj::Nsimd(),{ - auto z=coalescedRead(zz); + auto z=coalescedRead(Bp[ss]); + z=Zero(); coalescedWrite(Bp[ss],z); }); @@ -158,12 +158,12 @@ void basisRotateJ(Field &result,std::vector &basis,Eigen::MatrixXd& Qt,in for(int k=0;k Qt_jv(Nm); double * Qt_j = & Qt_jv[0]; for(int k=0;koSites(),vobj::Nsimd(),{ - auto B=coalescedRead(zz); + auto B=coalescedRead(basis_v[k0][ss]); + B=Zero(); for(int k=k0; k Date: Thu, 30 Apr 2020 19:40:04 +0100 Subject: [PATCH 21/36] Fix: strToVec enters infinite loop and exhausts memory if operator>> fails before the end of string, e.g. if parsing "0_0_0" for momentum instead of "0 0 0". --- Grid/serialisation/VectorUtils.h | 4 +--- 1 file changed, 1 insertion(+), 3 deletions(-) diff --git a/Grid/serialisation/VectorUtils.h b/Grid/serialisation/VectorUtils.h index a5a73992..dd5ff0b8 100644 --- a/Grid/serialisation/VectorUtils.h +++ b/Grid/serialisation/VectorUtils.h @@ -432,12 +432,10 @@ namespace Grid { std::vector strToVec(const std::string s) { std::istringstream sstr(s); - T buf; std::vector v; - while(!sstr.eof()) + for(T buf; sstr >> buf;) { - sstr >> buf; v.push_back(buf); } From ddb192bac73f7d0b2329f8bd43fe4d64e31f90e1 Mon Sep 17 00:00:00 2001 From: Christoph Lehner Date: Thu, 30 Apr 2020 16:09:57 -0400 Subject: [PATCH 22/36] re-work double precision promotion for summit --- Grid/lattice/Lattice_reduction.h | 2 +- Grid/parallelIO/NerscIO.h | 2 +- Grid/tensors/Tensor_traits.h | 92 ++++++++++++++++++++++++++++++-- 3 files changed, 90 insertions(+), 6 deletions(-) diff --git a/Grid/lattice/Lattice_reduction.h b/Grid/lattice/Lattice_reduction.h index d3f5f9ae..e2690cfe 100644 --- a/Grid/lattice/Lattice_reduction.h +++ b/Grid/lattice/Lattice_reduction.h @@ -234,7 +234,7 @@ innerProductNorm(ComplexD& ip, RealD &nrm, const Lattice &left,const Latti accelerator_for( ss, sites, nsimd,{ auto left_tmp = left_v(ss); coalescedWrite(inner_tmp_v[ss],innerProduct(left_tmp,right_v(ss))); - coalescedWrite(norm_tmp_v[ss],innerProduct(left_tmp,left_tmp))); + coalescedWrite(norm_tmp_v[ss],innerProduct(left_tmp,left_tmp)); }); tmp[0] = TensorRemove(sumD_gpu(inner_tmp_v,sites)); diff --git a/Grid/parallelIO/NerscIO.h b/Grid/parallelIO/NerscIO.h index d3b62d1f..5522ba91 100644 --- a/Grid/parallelIO/NerscIO.h +++ b/Grid/parallelIO/NerscIO.h @@ -146,7 +146,7 @@ public: int ieee32big = (format == std::string("IEEE32BIG")); int ieee32 = (format == std::string("IEEE32")); int ieee64big = (format == std::string("IEEE64BIG")); - int ieee64 = (format == std::string("IEEE64")); + int ieee64 = (format == std::string("IEEE64") || format == std::string("IEEE64LITTLE")); uint32_t nersc_csum,scidac_csuma,scidac_csumb; // depending on datatype, set up munger; diff --git a/Grid/tensors/Tensor_traits.h b/Grid/tensors/Tensor_traits.h index 5359c547..04d7343e 100644 --- a/Grid/tensors/Tensor_traits.h +++ b/Grid/tensors/Tensor_traits.h @@ -43,10 +43,38 @@ NAMESPACE_BEGIN(Grid); template struct isGridScalar> : public std::true_type { static constexpr bool notvalue = false; }; // Store double-precision data in single-precision grids for precision promoted localInnerProductD - typedef iVector ComplexD2; - typedef iVector vComplexD2; - typedef iVector RealD2; - typedef iVector vRealD2; + template + class TypePair { + public: + T _internal[2]; + TypePair& operator=(const Grid::Zero& o) { + _internal[0] = Zero(); + _internal[1] = Zero(); + return *this; + } + + TypePair operator+(const TypePair& o) const { + TypePair r; + r._internal[0] = _internal[0] + o._internal[0]; + r._internal[1] = _internal[1] + o._internal[1]; + return r; + } + + TypePair& operator+=(const TypePair& o) { + _internal[0] += o._internal[0]; + _internal[1] += o._internal[1]; + return *this; + } + + friend accelerator_inline void add(TypePair* ret, const TypePair* a, const TypePair* b) { + add(&ret->_internal[0],&a->_internal[0],&b->_internal[0]); + add(&ret->_internal[1],&a->_internal[1],&b->_internal[1]); + } + }; + typedef TypePair ComplexD2; + typedef TypePair RealD2; + typedef TypePair vComplexD2; + typedef TypePair vRealD2; // Traits to identify fundamental data types template struct isGridFundamental : public std::false_type { static constexpr bool notvalue = true; }; @@ -58,6 +86,10 @@ NAMESPACE_BEGIN(Grid); template<> struct isGridFundamental : public std::true_type { static constexpr bool notvalue = false; }; template<> struct isGridFundamental : public std::true_type { static constexpr bool notvalue = false; }; template<> struct isGridFundamental : public std::true_type { static constexpr bool notvalue = false; }; + template<> struct isGridFundamental : public std::true_type { static constexpr bool notvalue = false; }; + template<> struct isGridFundamental : public std::true_type { static constexpr bool notvalue = false; }; + template<> struct isGridFundamental : public std::true_type { static constexpr bool notvalue = false; }; + template<> struct isGridFundamental : public std::true_type { static constexpr bool notvalue = false; }; ////////////////////////////////////////////////////////////////////////////////// @@ -119,6 +151,19 @@ NAMESPACE_BEGIN(Grid); typedef RealD DoublePrecision; typedef RealD DoublePrecision2; }; + template<> struct GridTypeMapper : public GridTypeMapper_Base { + typedef RealD2 scalar_type; + typedef RealD2 scalar_typeD; + typedef RealD2 vector_type; + typedef RealD2 vector_typeD; + typedef RealD2 tensor_reduced; + typedef RealD2 scalar_object; + typedef RealD2 scalar_objectD; + typedef ComplexD2 Complexified; + typedef RealD2 Realified; + typedef RealD2 DoublePrecision; + typedef RealD2 DoublePrecision2; + }; template<> struct GridTypeMapper : public GridTypeMapper_Base { typedef ComplexF scalar_type; typedef ComplexD scalar_typeD; @@ -145,6 +190,19 @@ NAMESPACE_BEGIN(Grid); typedef ComplexD DoublePrecision; typedef ComplexD DoublePrecision2; }; + template<> struct GridTypeMapper : public GridTypeMapper_Base { + typedef ComplexD2 scalar_type; + typedef ComplexD2 scalar_typeD; + typedef ComplexD2 vector_type; + typedef ComplexD2 vector_typeD; + typedef ComplexD2 tensor_reduced; + typedef ComplexD2 scalar_object; + typedef ComplexD2 scalar_objectD; + typedef ComplexD2 Complexified; + typedef RealD2 Realified; + typedef ComplexD2 DoublePrecision; + typedef ComplexD2 DoublePrecision2; + }; template<> struct GridTypeMapper : public GridTypeMapper_Base { typedef Integer scalar_type; typedef Integer scalar_typeD; @@ -185,6 +243,19 @@ NAMESPACE_BEGIN(Grid); typedef vRealD DoublePrecision; typedef vRealD DoublePrecision2; }; + template<> struct GridTypeMapper : public GridTypeMapper_Base { + typedef RealD2 scalar_type; + typedef RealD2 scalar_typeD; + typedef vRealD2 vector_type; + typedef vRealD2 vector_typeD; + typedef vRealD2 tensor_reduced; + typedef RealD2 scalar_object; + typedef RealD2 scalar_objectD; + typedef vComplexD2 Complexified; + typedef vRealD2 Realified; + typedef vRealD2 DoublePrecision; + typedef vRealD2 DoublePrecision2; + }; template<> struct GridTypeMapper : public GridTypeMapper_Base { // Fixme this is incomplete until Grid supports fp16 or bfp16 arithmetic types typedef RealF scalar_type; @@ -239,6 +310,19 @@ NAMESPACE_BEGIN(Grid); typedef vComplexD DoublePrecision; typedef vComplexD DoublePrecision2; }; + template<> struct GridTypeMapper : public GridTypeMapper_Base { + typedef ComplexD2 scalar_type; + typedef ComplexD2 scalar_typeD; + typedef vComplexD2 vector_type; + typedef vComplexD2 vector_typeD; + typedef vComplexD2 tensor_reduced; + typedef ComplexD2 scalar_object; + typedef ComplexD2 scalar_objectD; + typedef vComplexD2 Complexified; + typedef vRealD2 Realified; + typedef vComplexD2 DoublePrecision; + typedef vComplexD2 DoublePrecision2; + }; template<> struct GridTypeMapper : public GridTypeMapper_Base { typedef Integer scalar_type; typedef Integer scalar_typeD; From c8af498a2abb195f606b389a12824bf3e65315f7 Mon Sep 17 00:00:00 2001 From: Christoph Lehner Date: Fri, 1 May 2020 03:45:50 -0400 Subject: [PATCH 23/36] BinaryIO fix for alternative little-endian format name (used in 96I ensemble) --- Grid/parallelIO/BinaryIO.h | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/Grid/parallelIO/BinaryIO.h b/Grid/parallelIO/BinaryIO.h index f90c34a9..1f11add9 100644 --- a/Grid/parallelIO/BinaryIO.h +++ b/Grid/parallelIO/BinaryIO.h @@ -341,7 +341,7 @@ class BinaryIO { int ieee32big = (format == std::string("IEEE32BIG")); int ieee32 = (format == std::string("IEEE32")); int ieee64big = (format == std::string("IEEE64BIG")); - int ieee64 = (format == std::string("IEEE64")); + int ieee64 = (format == std::string("IEEE64") || format == std::string("IEEE64LITTLE")); assert(ieee64||ieee32|ieee64big||ieee32big); assert((ieee64+ieee32+ieee64big+ieee32big)==1); ////////////////////////////////////////////////////////////////////////////// From 63cf201ee7ad32271537e5bbfe70d4df049a83f5 Mon Sep 17 00:00:00 2001 From: Christoph Lehner Date: Sat, 2 May 2020 11:38:42 -0400 Subject: [PATCH 24/36] Add AdviseInfrequentUse --- Grid/lattice/Lattice_base.h | 9 +++++++++ 1 file changed, 9 insertions(+) diff --git a/Grid/lattice/Lattice_base.h b/Grid/lattice/Lattice_base.h index ec7c54ec..a16b4fa8 100644 --- a/Grid/lattice/Lattice_base.h +++ b/Grid/lattice/Lattice_base.h @@ -9,6 +9,7 @@ Copyright (C) 2015 Author: Azusa Yamaguchi Author: Peter Boyle Author: paboyle +Author: Christoph Lehner 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 @@ -75,6 +76,14 @@ public: if (grid) conformable(grid, _grid); else grid = _grid; }; + + // Advise that the data is used infrequently. This can + // significantly influence performance of bulk storage. + accelerator_inline void AdviseInfrequentUse() { +#ifdef __CUDA_ARCH__ + cudaMemAdvise(_odata,_odata_size*sizeof(vobj),cudaMemAdviseSetPreferredLocation,cudaCpuDeviceId); +#endif + }; }; ///////////////////////////////////////////////////////////////////////////////////////// From 949be9605cf2d801439ec38ad85aa9554b29eb58 Mon Sep 17 00:00:00 2001 From: Christoph Lehner Date: Sat, 2 May 2020 16:20:03 -0400 Subject: [PATCH 25/36] fix pragmas --- Grid/lattice/Lattice_base.h | 4 +++- 1 file changed, 3 insertions(+), 1 deletion(-) diff --git a/Grid/lattice/Lattice_base.h b/Grid/lattice/Lattice_base.h index a16b4fa8..271ab43e 100644 --- a/Grid/lattice/Lattice_base.h +++ b/Grid/lattice/Lattice_base.h @@ -80,8 +80,10 @@ public: // Advise that the data is used infrequently. This can // significantly influence performance of bulk storage. accelerator_inline void AdviseInfrequentUse() { -#ifdef __CUDA_ARCH__ +#ifdef GRID_NVCC +#ifndef __CUDA_ARCH__ // only on host cudaMemAdvise(_odata,_odata_size*sizeof(vobj),cudaMemAdviseSetPreferredLocation,cudaCpuDeviceId); +#endif #endif }; }; From 38532753f40a28b98d648e0896138f9fab9c3cf9 Mon Sep 17 00:00:00 2001 From: Christoph Lehner Date: Sun, 3 May 2020 08:58:32 -0400 Subject: [PATCH 26/36] interface cleanup --- Grid/lattice/Lattice_base.h | 16 ++++++++++++---- 1 file changed, 12 insertions(+), 4 deletions(-) diff --git a/Grid/lattice/Lattice_base.h b/Grid/lattice/Lattice_base.h index 271ab43e..1e8b4152 100644 --- a/Grid/lattice/Lattice_base.h +++ b/Grid/lattice/Lattice_base.h @@ -50,6 +50,14 @@ void accelerator_inline conformable(GridBase *lhs,GridBase *rhs) assert(lhs == rhs); } +//////////////////////////////////////////////////////////////////////////// +// Advise for memory management +//////////////////////////////////////////////////////////////////////////// +enum LatticeAcceleratorAdvise { + AdviseInfrequentUse = 0x1 // Advise that the data is used infrequently. This can + // significantly influence performance of bulk storage. +}; + //////////////////////////////////////////////////////////////////////////// // Minimal base class containing only data valid to access from accelerator // _odata will be a managed pointer in CUDA @@ -77,12 +85,12 @@ public: else grid = _grid; }; - // Advise that the data is used infrequently. This can - // significantly influence performance of bulk storage. - accelerator_inline void AdviseInfrequentUse() { + accelerator_inline void Advise(int advise) { #ifdef GRID_NVCC #ifndef __CUDA_ARCH__ // only on host - cudaMemAdvise(_odata,_odata_size*sizeof(vobj),cudaMemAdviseSetPreferredLocation,cudaCpuDeviceId); + if (advise & AdviseInfrequentUse) { + cudaMemAdvise(_odata,_odata_size*sizeof(vobj),cudaMemAdviseSetPreferredLocation,cudaCpuDeviceId); + } #endif #endif }; From 9bfa51bffbd3550b4ee2f3cd7594ccb5bbe75535 Mon Sep 17 00:00:00 2001 From: Christoph Lehner Date: Sun, 3 May 2020 09:12:52 -0400 Subject: [PATCH 27/36] cleanup comment --- Grid/lattice/Lattice_base.h | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/Grid/lattice/Lattice_base.h b/Grid/lattice/Lattice_base.h index 1e8b4152..157c647b 100644 --- a/Grid/lattice/Lattice_base.h +++ b/Grid/lattice/Lattice_base.h @@ -51,7 +51,7 @@ void accelerator_inline conformable(GridBase *lhs,GridBase *rhs) } //////////////////////////////////////////////////////////////////////////// -// Advise for memory management +// Advise the LatticeAccelerator class //////////////////////////////////////////////////////////////////////////// enum LatticeAcceleratorAdvise { AdviseInfrequentUse = 0x1 // Advise that the data is used infrequently. This can From 2a1387e992781258ffaf636142bb0bb13b168997 Mon Sep 17 00:00:00 2001 From: Christoph Lehner Date: Sun, 3 May 2020 17:27:11 -0400 Subject: [PATCH 28/36] rankInnerProduct --- Grid/lattice/Lattice_reduction.h | 14 +++++++++++--- 1 file changed, 11 insertions(+), 3 deletions(-) diff --git a/Grid/lattice/Lattice_reduction.h b/Grid/lattice/Lattice_reduction.h index e2690cfe..8acbde66 100644 --- a/Grid/lattice/Lattice_reduction.h +++ b/Grid/lattice/Lattice_reduction.h @@ -5,6 +5,7 @@ Author: Azusa Yamaguchi Author: Peter Boyle Author: paboyle +Author: Christoph Lehner 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 @@ -93,7 +94,7 @@ template inline RealD norm2(const Lattice &arg){ // Double inner product template -inline ComplexD innerProduct(const Lattice &left,const Lattice &right) +inline ComplexD rankInnerProduct(const Lattice &left,const Lattice &right) { typedef typename vobj::scalar_type scalar_type; typedef typename vobj::vector_typeD vector_type; @@ -137,11 +138,18 @@ inline ComplexD innerProduct(const Lattice &left,const Lattice &righ }) nrm = TensorRemove(sum(inner_tmp_v,sites)); #endif - grid->GlobalSum(nrm); - return nrm; } +template +inline ComplexD innerProduct(const Lattice &left,const Lattice &right) { + GridBase *grid = left.Grid(); + ComplexD nrm = rankInnerProduct(left,right); + grid->GlobalSum(nrm); + return nrm; +} + + ///////////////////////// // Fast axpby_norm // z = a x + b y From fc19cf905b03c8ce5fc876c845a8ea53b4cb85a7 Mon Sep 17 00:00:00 2001 From: u37294 Date: Mon, 4 May 2020 10:24:48 -0700 Subject: [PATCH 29/36] Lime optional --- configure.ac | 2 +- 1 file changed, 1 insertion(+), 1 deletion(-) diff --git a/configure.ac b/configure.ac index 3d4ee383..bef17a84 100644 --- a/configure.ac +++ b/configure.ac @@ -226,7 +226,7 @@ AC_SEARCH_LIBS([fftw_execute], [fftw3], AC_SEARCH_LIBS([limeCreateReader], [lime], [AC_DEFINE([HAVE_LIME], [1], [Define to 1 if you have the `LIME' library])] [have_lime=true], - [AC_MSG_ERROR(LIME library was not found in your system.)]) + [AC_MSG_WARN(LIME library was not found in your system.)]) AC_SEARCH_LIBS([SHA256_Init], [crypto], [AC_DEFINE([HAVE_CRYPTO], [1], [Define to 1 if you have the `OpenSSL' library])] From 59c51d2c35f0b2af77adb508ee87dd484c2a14b5 Mon Sep 17 00:00:00 2001 From: u37294 Date: Mon, 4 May 2020 10:26:20 -0700 Subject: [PATCH 30/36] Make compile if HAVE_LIME=0 --- benchmarks/Benchmark_IO.cc | 3 ++- benchmarks/Benchmark_IO.hpp | 3 ++- benchmarks/Benchmark_IO_vs_dir.cc | 3 ++- 3 files changed, 6 insertions(+), 3 deletions(-) diff --git a/benchmarks/Benchmark_IO.cc b/benchmarks/Benchmark_IO.cc index 3d3b0ce0..c8c0937f 100644 --- a/benchmarks/Benchmark_IO.cc +++ b/benchmarks/Benchmark_IO.cc @@ -14,6 +14,7 @@ std::string filestem(const int l) int main (int argc, char ** argv) { +#ifdef HAVE_LIME Grid_init(&argc,&argv); int64_t threads = GridThread::GetThreads(); @@ -42,6 +43,6 @@ int main (int argc, char ** argv) } Grid_finalize(); - +#endif return EXIT_SUCCESS; } diff --git a/benchmarks/Benchmark_IO.hpp b/benchmarks/Benchmark_IO.hpp index 91fcb61f..d3416353 100644 --- a/benchmarks/Benchmark_IO.hpp +++ b/benchmarks/Benchmark_IO.hpp @@ -2,7 +2,7 @@ #define Benchmark_IO_hpp_ #include - +#ifdef HAVE_LIME #define MSG std::cout << GridLogMessage #define SEP \ "=============================================================================" @@ -104,4 +104,5 @@ void readBenchmark(const Coordinate &latt, const std::string filename, } +#endif //LIME #endif // Benchmark_IO_hpp_ diff --git a/benchmarks/Benchmark_IO_vs_dir.cc b/benchmarks/Benchmark_IO_vs_dir.cc index cb4831ed..6e6c9ae0 100644 --- a/benchmarks/Benchmark_IO_vs_dir.cc +++ b/benchmarks/Benchmark_IO_vs_dir.cc @@ -8,6 +8,7 @@ using namespace Grid; int main (int argc, char ** argv) { +#ifdef HAVE_LIME std::vector dir; unsigned int Ls; bool rb; @@ -73,6 +74,6 @@ int main (int argc, char ** argv) } Grid_finalize(); - +#endif return EXIT_SUCCESS; } From 7caed4edd9b7b22e8af97b3679572e7684a2a5e2 Mon Sep 17 00:00:00 2001 From: u37294 Date: Mon, 4 May 2020 10:27:05 -0700 Subject: [PATCH 31/36] dpc++ didn't like rdtsc() --- Grid/perfmon/PerfCount.h | 3 ++- 1 file changed, 2 insertions(+), 1 deletion(-) diff --git a/Grid/perfmon/PerfCount.h b/Grid/perfmon/PerfCount.h index b8229eec..1e2a9528 100644 --- a/Grid/perfmon/PerfCount.h +++ b/Grid/perfmon/PerfCount.h @@ -95,7 +95,8 @@ inline uint64_t cyclecount(void){ } #elif defined __x86_64__ inline uint64_t cyclecount(void){ - return __rdtsc(); + uint64_t ret = __rdtsc(); + return (uint64_t)ret; } #else From 04927d2e40bef33c7ca9703198f049f02d571c6a Mon Sep 17 00:00:00 2001 From: u37294 Date: Mon, 4 May 2020 10:28:29 -0700 Subject: [PATCH 32/36] SYCL prep - no sycl just make it compile through DPC++ --- Grid/Grid_Eigen_Dense.h | 17 +++++++++++++++++ 1 file changed, 17 insertions(+) diff --git a/Grid/Grid_Eigen_Dense.h b/Grid/Grid_Eigen_Dense.h index f9bccf2d..9d779e05 100644 --- a/Grid/Grid_Eigen_Dense.h +++ b/Grid/Grid_Eigen_Dense.h @@ -22,8 +22,18 @@ #undef __CUDACC__ #undef __CUDA_ARCH__ #define __NVCC__REDEFINE__ +#endif + +/* SYCL save and restore compile environment*/ +#ifdef __SYCL_DEVICE_ONLY__ +#pragma push +#pragma push_macro("__SYCL_DEVICE_ONLY__") +#undef __SYCL_DEVICE_ONLY__ +#undef EIGEN_USE_SYCL +#define EIGEN_DONT_VECTORIZE #endif + #include #include @@ -35,7 +45,14 @@ #pragma pop #endif +/*SYCL restore*/ +#ifdef __SYCL__REDEFINE__ +#pragma pop_macro("__SYCL_DEVICE_ONLY__") +#pragma pop +#endif + #if defined __GNUC__ #pragma GCC diagnostic pop #endif + From 04863f8f3835bbfec9f913139eddc1dca717bbb2 Mon Sep 17 00:00:00 2001 From: Christoph Lehner Date: Mon, 4 May 2020 16:07:03 -0400 Subject: [PATCH 33/36] debug new AcceleratorView --- Grid/lattice/Lattice_ET.h | 3 +- Grid/lattice/Lattice_arith.h | 69 ++++++++++++++++--------------- Grid/lattice/Lattice_base.h | 71 +++++++++++++++++++++++++++----- Grid/lattice/Lattice_reduction.h | 14 +++---- 4 files changed, 105 insertions(+), 52 deletions(-) diff --git a/Grid/lattice/Lattice_ET.h b/Grid/lattice/Lattice_ET.h index cf7147b9..da63d5e6 100644 --- a/Grid/lattice/Lattice_ET.h +++ b/Grid/lattice/Lattice_ET.h @@ -9,6 +9,7 @@ Copyright (C) 2015 Author: Azusa Yamaguchi Author: Peter Boyle Author: neo +Author: Christoph Lehner &arg) template accelerator_inline const lobj & eval(const uint64_t ss, const Lattice &arg) { - auto view = arg.View(); + auto view = arg.AcceleratorView(ViewRead); return view[ss]; } diff --git a/Grid/lattice/Lattice_arith.h b/Grid/lattice/Lattice_arith.h index 3543d6aa..c4a67620 100644 --- a/Grid/lattice/Lattice_arith.h +++ b/Grid/lattice/Lattice_arith.h @@ -7,6 +7,7 @@ Copyright (C) 2015 Author: Peter Boyle +Author: Christoph Lehner 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 @@ -36,9 +37,9 @@ NAMESPACE_BEGIN(Grid); template inline void mult(Lattice &ret,const Lattice &lhs,const Lattice &rhs){ ret.Checkerboard() = lhs.Checkerboard(); - auto ret_v = ret.View(); - auto lhs_v = lhs.View(); - auto rhs_v = rhs.View(); + auto ret_v = ret.AcceleratorView(ViewWrite); + auto lhs_v = lhs.AcceleratorView(ViewRead); + auto rhs_v = rhs.AcceleratorView(ViewRead); conformable(ret,rhs); conformable(lhs,rhs); accelerator_for(ss,lhs_v.size(),obj1::Nsimd(),{ @@ -55,9 +56,9 @@ void mac(Lattice &ret,const Lattice &lhs,const Lattice &rhs){ ret.Checkerboard() = lhs.Checkerboard(); conformable(ret,rhs); conformable(lhs,rhs); - auto ret_v = ret.View(); - auto lhs_v = lhs.View(); - auto rhs_v = rhs.View(); + auto ret_v = ret.AcceleratorView(ViewWrite); + auto lhs_v = lhs.AcceleratorView(ViewRead); + auto rhs_v = rhs.AcceleratorView(ViewRead); accelerator_for(ss,lhs_v.size(),obj1::Nsimd(),{ decltype(coalescedRead(obj1())) tmp; auto lhs_t=lhs_v(ss); @@ -72,9 +73,9 @@ void sub(Lattice &ret,const Lattice &lhs,const Lattice &rhs){ ret.Checkerboard() = lhs.Checkerboard(); conformable(ret,rhs); conformable(lhs,rhs); - auto ret_v = ret.View(); - auto lhs_v = lhs.View(); - auto rhs_v = rhs.View(); + auto ret_v = ret.AcceleratorView(ViewWrite); + auto lhs_v = lhs.AcceleratorView(ViewRead); + auto rhs_v = rhs.AcceleratorView(ViewRead); accelerator_for(ss,lhs_v.size(),obj1::Nsimd(),{ decltype(coalescedRead(obj1())) tmp; auto lhs_t=lhs_v(ss); @@ -88,9 +89,9 @@ void add(Lattice &ret,const Lattice &lhs,const Lattice &rhs){ ret.Checkerboard() = lhs.Checkerboard(); conformable(ret,rhs); conformable(lhs,rhs); - auto ret_v = ret.View(); - auto lhs_v = lhs.View(); - auto rhs_v = rhs.View(); + auto ret_v = ret.AcceleratorView(ViewWrite); + auto lhs_v = lhs.AcceleratorView(ViewRead); + auto rhs_v = rhs.AcceleratorView(ViewRead); accelerator_for(ss,lhs_v.size(),obj1::Nsimd(),{ decltype(coalescedRead(obj1())) tmp; auto lhs_t=lhs_v(ss); @@ -107,8 +108,8 @@ template inline void mult(Lattice &ret,const Lattice &lhs,const obj3 &rhs){ ret.Checkerboard() = lhs.Checkerboard(); conformable(lhs,ret); - auto ret_v = ret.View(); - auto lhs_v = lhs.View(); + auto ret_v = ret.AcceleratorView(ViewWrite); + auto lhs_v = lhs.AcceleratorView(ViewRead); accelerator_for(ss,lhs_v.size(),obj1::Nsimd(),{ decltype(coalescedRead(obj1())) tmp; mult(&tmp,&lhs_v(ss),&rhs); @@ -120,8 +121,8 @@ template inline void mac(Lattice &ret,const Lattice &lhs,const obj3 &rhs){ ret.Checkerboard() = lhs.Checkerboard(); conformable(ret,lhs); - auto ret_v = ret.View(); - auto lhs_v = lhs.View(); + auto ret_v = ret.AcceleratorView(ViewWrite); + auto lhs_v = lhs.AcceleratorView(ViewRead); accelerator_for(ss,lhs_v.size(),obj1::Nsimd(),{ decltype(coalescedRead(obj1())) tmp; auto lhs_t=lhs_v(ss); @@ -134,8 +135,8 @@ template inline void sub(Lattice &ret,const Lattice &lhs,const obj3 &rhs){ ret.Checkerboard() = lhs.Checkerboard(); conformable(ret,lhs); - auto ret_v = ret.View(); - auto lhs_v = lhs.View(); + auto ret_v = ret.AcceleratorView(ViewWrite); + auto lhs_v = lhs.AcceleratorView(ViewRead); accelerator_for(ss,lhs_v.size(),obj1::Nsimd(),{ decltype(coalescedRead(obj1())) tmp; auto lhs_t=lhs_v(ss); @@ -147,8 +148,8 @@ template inline void add(Lattice &ret,const Lattice &lhs,const obj3 &rhs){ ret.Checkerboard() = lhs.Checkerboard(); conformable(lhs,ret); - auto ret_v = ret.View(); - auto lhs_v = lhs.View(); + auto ret_v = ret.AcceleratorView(ViewWrite); + auto lhs_v = lhs.AcceleratorView(ViewRead); accelerator_for(ss,lhs_v.size(),obj1::Nsimd(),{ decltype(coalescedRead(obj1())) tmp; auto lhs_t=lhs_v(ss); @@ -164,8 +165,8 @@ template inline void mult(Lattice &ret,const obj2 &lhs,const Lattice &rhs){ ret.Checkerboard() = rhs.Checkerboard(); conformable(ret,rhs); - auto ret_v = ret.View(); - auto rhs_v = lhs.View(); + auto ret_v = ret.AcceleratorView(ViewWrite); + auto rhs_v = lhs.AcceleratorView(ViewRead); accelerator_for(ss,rhs_v.size(),obj1::Nsimd(),{ decltype(coalescedRead(obj1())) tmp; auto rhs_t=rhs_v(ss); @@ -178,8 +179,8 @@ template inline void mac(Lattice &ret,const obj2 &lhs,const Lattice &rhs){ ret.Checkerboard() = rhs.Checkerboard(); conformable(ret,rhs); - auto ret_v = ret.View(); - auto rhs_v = lhs.View(); + auto ret_v = ret.AcceleratorView(ViewWrite); + auto rhs_v = lhs.AcceleratorView(ViewRead); accelerator_for(ss,rhs_v.size(),obj1::Nsimd(),{ decltype(coalescedRead(obj1())) tmp; auto rhs_t=rhs_v(ss); @@ -192,8 +193,8 @@ template inline void sub(Lattice &ret,const obj2 &lhs,const Lattice &rhs){ ret.Checkerboard() = rhs.Checkerboard(); conformable(ret,rhs); - auto ret_v = ret.View(); - auto rhs_v = lhs.View(); + auto ret_v = ret.AcceleratorView(ViewWrite); + auto rhs_v = lhs.AcceleratorView(ViewRead); accelerator_for(ss,rhs_v.size(),obj1::Nsimd(),{ decltype(coalescedRead(obj1())) tmp; auto rhs_t=rhs_v(ss); @@ -205,8 +206,8 @@ template inline void add(Lattice &ret,const obj2 &lhs,const Lattice &rhs){ ret.Checkerboard() = rhs.Checkerboard(); conformable(ret,rhs); - auto ret_v = ret.View(); - auto rhs_v = lhs.View(); + auto ret_v = ret.AcceleratorView(ViewWrite); + auto rhs_v = lhs.AcceleratorView(ViewRead); accelerator_for(ss,rhs_v.size(),obj1::Nsimd(),{ decltype(coalescedRead(obj1())) tmp; auto rhs_t=rhs_v(ss); @@ -220,9 +221,9 @@ void axpy(Lattice &ret,sobj a,const Lattice &x,const Lattice & ret.Checkerboard() = x.Checkerboard(); conformable(ret,x); conformable(x,y); - auto ret_v = ret.View(); - auto x_v = x.View(); - auto y_v = y.View(); + auto ret_v = ret.AcceleratorView(ViewWrite); + auto x_v = x.AcceleratorView(ViewRead); + auto y_v = y.AcceleratorView(ViewRead); accelerator_for(ss,x_v.size(),vobj::Nsimd(),{ auto tmp = a*x_v(ss)+y_v(ss); coalescedWrite(ret_v[ss],tmp); @@ -233,9 +234,9 @@ void axpby(Lattice &ret,sobj a,sobj b,const Lattice &x,const Lattice ret.Checkerboard() = x.Checkerboard(); conformable(ret,x); conformable(x,y); - auto ret_v = ret.View(); - auto x_v = x.View(); - auto y_v = y.View(); + auto ret_v = ret.AcceleratorView(ViewWrite); + auto x_v = x.AcceleratorView(ViewRead); + auto y_v = y.AcceleratorView(ViewRead); accelerator_for(ss,x_v.size(),vobj::Nsimd(),{ auto tmp = a*x_v(ss)+b*y_v(ss); coalescedWrite(ret_v[ss],tmp); diff --git a/Grid/lattice/Lattice_base.h b/Grid/lattice/Lattice_base.h index 157c647b..30aa6b06 100644 --- a/Grid/lattice/Lattice_base.h +++ b/Grid/lattice/Lattice_base.h @@ -54,8 +54,20 @@ void accelerator_inline conformable(GridBase *lhs,GridBase *rhs) // Advise the LatticeAccelerator class //////////////////////////////////////////////////////////////////////////// enum LatticeAcceleratorAdvise { - AdviseInfrequentUse = 0x1 // Advise that the data is used infrequently. This can - // significantly influence performance of bulk storage. + AdviseInfrequentUse = 0x1, // Advise that the data is used infrequently. This can + // significantly influence performance of bulk storage. + AdviseReadMostly = 0x2, // Data will mostly be read. On some architectures + // enables read-only copies of memory to be kept on + // host and device. +}; + +//////////////////////////////////////////////////////////////////////////// +// View Access Mode +//////////////////////////////////////////////////////////////////////////// +enum ViewMode { + ViewRead = 0x1, + ViewWrite = 0x2, + ViewReadWrite = 0x3 }; //////////////////////////////////////////////////////////////////////////// @@ -91,6 +103,29 @@ public: if (advise & AdviseInfrequentUse) { cudaMemAdvise(_odata,_odata_size*sizeof(vobj),cudaMemAdviseSetPreferredLocation,cudaCpuDeviceId); } + if (advise & AdviseReadMostly) { + cudaMemAdvise(_odata,_odata_size*sizeof(vobj),cudaMemAdviseSetReadMostly,-1); + } +#endif +#endif + }; + + accelerator_inline void AcceleratorPrefetch(int accessMode = ViewReadWrite) { // will use accessMode in future +#ifdef GRID_NVCC +#ifndef __CUDA_ARCH__ // only on host + int target; + cudaGetDevice(&target); + cudaMemPrefetchAsync(_odata,_odata_size*sizeof(vobj),target); + std::cout<< GridLogMessage << "To Device " << target << std::endl; +#endif +#endif + }; + + accelerator_inline void HostPrefetch(int accessMode = ViewReadWrite) { // will use accessMode in future +#ifdef GRID_NVCC +#ifndef __CUDA_ARCH__ // only on host + cudaMemPrefetchAsync(_odata,_odata_size*sizeof(vobj),cudaCpuDeviceId); + std::cout<< GridLogMessage << "To Host" << std::endl; #endif #endif }; @@ -225,9 +260,23 @@ public: // The view is trivially copy constructible and may be copied to an accelerator device // in device lambdas ///////////////////////////////////////////////////////////////////////////////// - LatticeView View (void) const + LatticeView View (void) const // deprecated, should pick AcceleratorView for accelerator_for + { // and HostView for thread_for + LatticeView accessor(*( (LatticeAccelerator *) this)); + return accessor; + } + + LatticeView AcceleratorView(int mode = ViewReadWrite) const { LatticeView accessor(*( (LatticeAccelerator *) this)); + accessor.AcceleratorPrefetch(mode); + return accessor; + } + + LatticeView HostView(int mode = ViewReadWrite) const + { + LatticeView accessor(*( (LatticeAccelerator *) this)); + accessor.HostPrefetch(mode); return accessor; } @@ -251,7 +300,7 @@ public: assert( (cb==Odd) || (cb==Even)); this->checkerboard=cb; - auto me = View(); + auto me = AcceleratorView(ViewWrite); accelerator_for(ss,me.size(),1,{ auto tmp = eval(ss,expr); vstream(me[ss],tmp); @@ -270,7 +319,7 @@ public: assert( (cb==Odd) || (cb==Even)); this->checkerboard=cb; - auto me = View(); + auto me = AcceleratorView(ViewWrite); accelerator_for(ss,me.size(),1,{ auto tmp = eval(ss,expr); vstream(me[ss],tmp); @@ -288,7 +337,7 @@ public: CBFromExpression(cb,expr); assert( (cb==Odd) || (cb==Even)); this->checkerboard=cb; - auto me = View(); + auto me = AcceleratorView(ViewWrite); accelerator_for(ss,me.size(),1,{ auto tmp = eval(ss,expr); vstream(me[ss],tmp); @@ -399,8 +448,9 @@ public: typename std::enable_if::value,int>::type i=0; conformable(*this,r); this->checkerboard = r.Checkerboard(); - auto me = View(); - auto him= r.View(); + std::cout << GridLogMessage << "Copy other" << std::endl; + auto me = AcceleratorView(ViewWrite); + auto him= r.AcceleratorView(ViewRead); accelerator_for(ss,me.size(),vobj::Nsimd(),{ coalescedWrite(me[ss],him(ss)); }); @@ -413,8 +463,9 @@ public: inline Lattice & operator = (const Lattice & r){ this->checkerboard = r.Checkerboard(); conformable(*this,r); - auto me = View(); - auto him= r.View(); + std::cout << GridLogMessage << "Copy same" << std::endl; + auto me = AcceleratorView(ViewWrite); + auto him= r.AcceleratorView(ViewRead); accelerator_for(ss,me.size(),vobj::Nsimd(),{ coalescedWrite(me[ss],him(ss)); }); diff --git a/Grid/lattice/Lattice_reduction.h b/Grid/lattice/Lattice_reduction.h index 8acbde66..3147823d 100644 --- a/Grid/lattice/Lattice_reduction.h +++ b/Grid/lattice/Lattice_reduction.h @@ -103,8 +103,8 @@ inline ComplexD rankInnerProduct(const Lattice &left,const Lattice & GridBase *grid = left.Grid(); // Might make all code paths go this way. - auto left_v = left.View(); - auto right_v=right.View(); + auto left_v = left.AcceleratorView(ViewRead); + auto right_v=right.AcceleratorView(ViewRead); const uint64_t nsimd = grid->Nsimd(); const uint64_t sites = grid->oSites(); @@ -175,9 +175,9 @@ axpby_norm_fast(Lattice &z,sobj a,sobj b,const Lattice &x,const Latt GridBase *grid = x.Grid(); - auto x_v=x.View(); - auto y_v=y.View(); - auto z_v=z.View(); + auto x_v=x.AcceleratorView(ViewRead); + auto y_v=y.AcceleratorView(ViewRead); + auto z_v=z.AcceleratorView(ViewWrite); const uint64_t nsimd = grid->Nsimd(); const uint64_t sites = grid->oSites(); @@ -224,8 +224,8 @@ innerProductNorm(ComplexD& ip, RealD &nrm, const Lattice &left,const Latti GridBase *grid = left.Grid(); - auto left_v=left.View(); - auto right_v=right.View(); + auto left_v=left.AcceleratorView(ViewRead); + auto right_v=right.AcceleratorView(ViewRead); const uint64_t nsimd = grid->Nsimd(); const uint64_t sites = grid->oSites(); From 6b64727161b4328d54ed919be2979ba518614c37 Mon Sep 17 00:00:00 2001 From: Christoph Lehner Date: Tue, 5 May 2020 05:05:36 -0400 Subject: [PATCH 34/36] disable comments --- Grid/lattice/Lattice_base.h | 8 ++++---- 1 file changed, 4 insertions(+), 4 deletions(-) diff --git a/Grid/lattice/Lattice_base.h b/Grid/lattice/Lattice_base.h index 30aa6b06..0b03dea0 100644 --- a/Grid/lattice/Lattice_base.h +++ b/Grid/lattice/Lattice_base.h @@ -116,7 +116,7 @@ public: int target; cudaGetDevice(&target); cudaMemPrefetchAsync(_odata,_odata_size*sizeof(vobj),target); - std::cout<< GridLogMessage << "To Device " << target << std::endl; + //std::cout<< GridLogMessage << "To Device " << target << std::endl; #endif #endif }; @@ -125,7 +125,7 @@ public: #ifdef GRID_NVCC #ifndef __CUDA_ARCH__ // only on host cudaMemPrefetchAsync(_odata,_odata_size*sizeof(vobj),cudaCpuDeviceId); - std::cout<< GridLogMessage << "To Host" << std::endl; + //std::cout<< GridLogMessage << "To Host" << std::endl; #endif #endif }; @@ -448,7 +448,7 @@ public: typename std::enable_if::value,int>::type i=0; conformable(*this,r); this->checkerboard = r.Checkerboard(); - std::cout << GridLogMessage << "Copy other" << std::endl; + //std::cout << GridLogMessage << "Copy other" << std::endl; auto me = AcceleratorView(ViewWrite); auto him= r.AcceleratorView(ViewRead); accelerator_for(ss,me.size(),vobj::Nsimd(),{ @@ -463,7 +463,7 @@ public: inline Lattice & operator = (const Lattice & r){ this->checkerboard = r.Checkerboard(); conformable(*this,r); - std::cout << GridLogMessage << "Copy same" << std::endl; + //std::cout << GridLogMessage << "Copy same" << std::endl; auto me = AcceleratorView(ViewWrite); auto him= r.AcceleratorView(ViewRead); accelerator_for(ss,me.size(),vobj::Nsimd(),{ From e9b295f967c03bfe200880cd834721b2583dced5 Mon Sep 17 00:00:00 2001 From: Christoph Lehner Date: Wed, 6 May 2020 08:42:28 -0400 Subject: [PATCH 35/36] Synchronize blocking infrastructure with GPT --- .../iterative/ImplicitlyRestartedLanczos.h | 205 ------------- Grid/lattice/Lattice.h | 2 +- Grid/lattice/Lattice_base.h | 5 - Grid/lattice/Lattice_transfer.h | 286 +++++++++++++----- 4 files changed, 216 insertions(+), 282 deletions(-) diff --git a/Grid/algorithms/iterative/ImplicitlyRestartedLanczos.h b/Grid/algorithms/iterative/ImplicitlyRestartedLanczos.h index 8bee43cc..3d0a2a75 100644 --- a/Grid/algorithms/iterative/ImplicitlyRestartedLanczos.h +++ b/Grid/algorithms/iterative/ImplicitlyRestartedLanczos.h @@ -37,211 +37,6 @@ Author: Christoph Lehner NAMESPACE_BEGIN(Grid); - //////////////////////////////////////////////////////// - // Move following 100 LOC to lattice/Lattice_basis.h - //////////////////////////////////////////////////////// -template -void basisOrthogonalize(std::vector &basis,Field &w,int k) -{ - // If assume basis[j] are already orthonormal, - // can take all inner products in parallel saving 2x bandwidth - // Save 3x bandwidth on the second line of loop. - // perhaps 2.5x speed up. - // 2x overall in Multigrid Lanczos - for(int j=0; j -void basisRotate(std::vector &basis,Eigen::MatrixXd& Qt,int j0, int j1, int k0,int k1,int Nm) -{ - typedef decltype(basis[0].View()) View; - auto tmp_v = basis[0].View(); - Vector basis_v(basis.size(),tmp_v); - typedef typename Field::vector_object vobj; - GridBase* grid = basis[0].Grid(); - - for(int k=0;k > Bt(thread_max() * Nm); // Thread private - thread_region - { - vobj* B = Bt.data() + Nm * thread_num(); - - thread_for_in_region(ss, grid->oSites(),{ - for(int j=j0; joSites(); - uint64_t siteBlock=(grid->oSites()+nrot-1)/nrot; // Maximum 1 additional vector overhead - - // printf("BasisRotate %d %d nrot %d siteBlock %d\n",j0,j1,nrot,siteBlock); - - Vector Bt(siteBlock * nrot); - auto Bp=&Bt[0]; - - // GPU readable copy of Eigen matrix - Vector Qt_jv(Nm*Nm); - double *Qt_p = & Qt_jv[0]; - for(int k=0;k -void basisRotateJ(Field &result,std::vector &basis,Eigen::MatrixXd& Qt,int j, int k0,int k1,int Nm) -{ - typedef decltype(basis[0].View()) View; - typedef typename Field::vector_object vobj; - GridBase* grid = basis[0].Grid(); - - result.Checkerboard() = basis[0].Checkerboard(); - auto result_v=result.View(); - Vector basis_v(basis.size(),result_v); - for(int k=0;k Qt_jv(Nm); - double * Qt_j = & Qt_jv[0]; - for(int k=0;koSites(),vobj::Nsimd(),{ - auto B=coalescedRead(zz); - for(int k=k0; k -void basisReorderInPlace(std::vector &_v,std::vector& sort_vals, std::vector& idx) -{ - int vlen = idx.size(); - - assert(vlen>=1); - assert(vlen<=sort_vals.size()); - assert(vlen<=_v.size()); - - for (size_t i=0;ii for which _vnew[j] = _vold[i], - // track the move idx[j] => idx[i] - // track the move idx[i] => i - ////////////////////////////////////// - size_t j; - for (j=i;j i); assert(j!=idx.size()); assert(idx[j]==i); - - swap(_v[i],_v[idx[i]]); // should use vector move constructor, no data copy - std::swap(sort_vals[i],sort_vals[idx[i]]); - - idx[j] = idx[i]; - idx[i] = i; - } - } -} - -inline std::vector basisSortGetIndex(std::vector& sort_vals) -{ - std::vector idx(sort_vals.size()); - std::iota(idx.begin(), idx.end(), 0); - - // sort indexes based on comparing values in v - std::sort(idx.begin(), idx.end(), [&sort_vals](int i1, int i2) { - return ::fabs(sort_vals[i1]) < ::fabs(sort_vals[i2]); - }); - return idx; -} - -template -void basisSortInPlace(std::vector & _v,std::vector& sort_vals, bool reverse) -{ - std::vector idx = basisSortGetIndex(sort_vals); - if (reverse) - std::reverse(idx.begin(), idx.end()); - - basisReorderInPlace(_v,sort_vals,idx); -} - -// PAB: faster to compute the inner products first then fuse loops. -// If performance critical can improve. -template -void basisDeflate(const std::vector &_v,const std::vector& eval,const Field& src_orig,Field& result) { - result = Zero(); - assert(_v.size()==eval.size()); - int N = (int)_v.size(); - for (int i=0;i #include #include #include - +#include diff --git a/Grid/lattice/Lattice_base.h b/Grid/lattice/Lattice_base.h index 0b03dea0..74525cc1 100644 --- a/Grid/lattice/Lattice_base.h +++ b/Grid/lattice/Lattice_base.h @@ -116,7 +116,6 @@ public: int target; cudaGetDevice(&target); cudaMemPrefetchAsync(_odata,_odata_size*sizeof(vobj),target); - //std::cout<< GridLogMessage << "To Device " << target << std::endl; #endif #endif }; @@ -125,7 +124,6 @@ public: #ifdef GRID_NVCC #ifndef __CUDA_ARCH__ // only on host cudaMemPrefetchAsync(_odata,_odata_size*sizeof(vobj),cudaCpuDeviceId); - //std::cout<< GridLogMessage << "To Host" << std::endl; #endif #endif }; @@ -425,7 +423,6 @@ public: // copy constructor /////////////////////////////////////////// Lattice(const Lattice& r){ - // std::cout << "Lattice constructor(const Lattice &) "<_grid = r.Grid(); resize(this->_grid->oSites()); *this = r; @@ -448,7 +445,6 @@ public: typename std::enable_if::value,int>::type i=0; conformable(*this,r); this->checkerboard = r.Checkerboard(); - //std::cout << GridLogMessage << "Copy other" << std::endl; auto me = AcceleratorView(ViewWrite); auto him= r.AcceleratorView(ViewRead); accelerator_for(ss,me.size(),vobj::Nsimd(),{ @@ -463,7 +459,6 @@ public: inline Lattice & operator = (const Lattice & r){ this->checkerboard = r.Checkerboard(); conformable(*this,r); - //std::cout << GridLogMessage << "Copy same" << std::endl; auto me = AcceleratorView(ViewWrite); auto him= r.AcceleratorView(ViewRead); accelerator_for(ss,me.size(),vobj::Nsimd(),{ diff --git a/Grid/lattice/Lattice_transfer.h b/Grid/lattice/Lattice_transfer.h index c80e7db2..c23ddcdc 100644 --- a/Grid/lattice/Lattice_transfer.h +++ b/Grid/lattice/Lattice_transfer.h @@ -6,6 +6,7 @@ Copyright (C) 2015 Author: Peter Boyle +Author: Christoph Lehner 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 @@ -63,6 +64,7 @@ template inline void pickCheckerboard(int cb,Lattice &half,con } }); } + template inline void setCheckerboard(Lattice &full,const Lattice &half){ int cb = half.Checkerboard(); auto half_v = half.View(); @@ -81,25 +83,130 @@ template inline void setCheckerboard(Lattice &full,const Latti } }); } - -template + +//////////////////////////////////////////////////////////////////////////////////////////// +// Flexible Type Conversion for internal promotion to double as well as graceful +// treatment of scalar-compatible types +//////////////////////////////////////////////////////////////////////////////////////////// +accelerator_inline void convertType(ComplexD & out, const std::complex & in) { + out = in; +} + +accelerator_inline void convertType(ComplexF & out, const std::complex & in) { + out = in; +} + +#ifdef __CUDA_ARCH__ +accelerator_inline void convertType(vComplexF & out, const ComplexF & in) { + ((ComplexF*)&out)[SIMTlane(vComplexF::Nsimd())] = in; +} +accelerator_inline void convertType(vComplexD & out, const ComplexD & in) { + ((ComplexD*)&out)[SIMTlane(vComplexD::Nsimd())] = in; +} +accelerator_inline void convertType(vComplexD2 & out, const ComplexD & in) { + ((ComplexD*)&out)[SIMTlane(vComplexD::Nsimd()*2)] = in; +} +#endif + +accelerator_inline void convertType(vComplexF & out, const vComplexD2 & in) { + out.v = Optimization::PrecisionChange::DtoS(in._internal[0].v,in._internal[1].v); +} + +accelerator_inline void convertType(vComplexD2 & out, const vComplexF & in) { + Optimization::PrecisionChange::StoD(in.v,out._internal[0].v,out._internal[1].v); +} + +template + accelerator_inline void convertType(iMatrix & out, const iMatrix & in); +template + accelerator_inline void convertType(iVector & out, const iVector & in); + +template::value, T1>::type* = nullptr> +accelerator_inline void convertType(T1 & out, const iScalar & in) { + convertType(out,in._internal); +} + +template +accelerator_inline void convertType(iScalar & out, const T2 & in) { + convertType(out._internal,in); +} + +template +accelerator_inline void convertType(iMatrix & out, const iMatrix & in) { + for (int i=0;i +accelerator_inline void convertType(iVector & out, const iVector & in) { + for (int i=0;i::value, T>::type* = nullptr> +accelerator_inline void convertType(T & out, const T & in) { + out = in; +} + +template +accelerator_inline void convertType(Lattice & out, const Lattice & in) { + auto out_v = out.AcceleratorView(ViewWrite); + auto in_v = in.AcceleratorView(ViewRead); + + accelerator_for(ss,out_v.size(),T1::Nsimd(),{ + convertType(out_v[ss],in_v(ss)); + }); +} + +//////////////////////////////////////////////////////////////////////////////////////////// +// precision-promoted local inner product +//////////////////////////////////////////////////////////////////////////////////////////// +template +inline auto localInnerProductD(const Lattice &lhs,const Lattice &rhs) +-> Lattice> +{ + auto lhs_v = lhs.AcceleratorView(ViewRead); + auto rhs_v = rhs.AcceleratorView(ViewRead); + + typedef decltype(TensorRemove(innerProductD2(lhs_v[0],rhs_v[0]))) t_inner; + Lattice> ret(lhs.Grid()); + auto ret_v = ret.AcceleratorView(ViewWrite); + + accelerator_for(ss,rhs_v.size(),vobj::Nsimd(),{ + convertType(ret_v[ss],innerProductD2(lhs_v(ss),rhs_v(ss))); + }); + + return ret; +} + +//////////////////////////////////////////////////////////////////////////////////////////// +// block routines +//////////////////////////////////////////////////////////////////////////////////////////// +template inline void blockProject(Lattice > &coarseData, - const Lattice &fineData, - const std::vector > &Basis) + const Lattice &fineData, + const VLattice &Basis) { GridBase * fine = fineData.Grid(); GridBase * coarse= coarseData.Grid(); - Lattice ip(coarse); + Lattice> ip(coarse); + Lattice fineDataRed = fineData; // auto fineData_ = fineData.View(); - auto coarseData_ = coarseData.View(); - auto ip_ = ip.View(); + auto coarseData_ = coarseData.AcceleratorView(ViewWrite); + auto ip_ = ip.AcceleratorView(ViewReadWrite); for(int v=0;v accelerator_for( sc, coarse->oSites(), vobj::Nsimd(), { - coalescedWrite(coarseData_[sc](v),ip_(sc)); + convertType(coarseData_[sc](v),ip_[sc]); }); + + // improve numerical stability of projection + // |fine> = |fine> - |basis> + ip=-ip; + blockZAXPY(fineDataRed,ip,Basis[v],fineDataRed); } } @@ -166,11 +273,11 @@ inline void blockProject1(Lattice > &coarseData, return; } -template -inline void blockZAXPY(Lattice &fineZ, - const Lattice &coarseA, - const Lattice &fineX, - const Lattice &fineY) +template + inline void blockZAXPY(Lattice &fineZ, + const Lattice &coarseA, + const Lattice &fineX, + const Lattice &fineY) { GridBase * fine = fineZ.Grid(); GridBase * coarse= coarseA.Grid(); @@ -182,7 +289,7 @@ inline void blockZAXPY(Lattice &fineZ, conformable(fineX,fineZ); int _ndimension = coarse->_ndimension; - + Coordinate block_r (_ndimension); // FIXME merge with subdivide checking routine as this is redundant @@ -191,29 +298,65 @@ inline void blockZAXPY(Lattice &fineZ, assert(block_r[d]*coarse->_rdimensions[d]==fine->_rdimensions[d]); } - auto fineZ_ = fineZ.View(); - auto fineX_ = fineX.View(); - auto fineY_ = fineY.View(); - auto coarseA_= coarseA.View(); + auto fineZ_ = fineZ.AcceleratorView(ViewWrite); + auto fineX_ = fineX.AcceleratorView(ViewRead); + auto fineY_ = fineY.AcceleratorView(ViewRead); + auto coarseA_= coarseA.AcceleratorView(ViewRead); accelerator_for(sf, fine->oSites(), CComplex::Nsimd(), { - - int sc; - Coordinate coor_c(_ndimension); - Coordinate coor_f(_ndimension); - Lexicographic::CoorFromIndex(coor_f,sf,fine->_rdimensions); - for(int d=0;d<_ndimension;d++) coor_c[d]=coor_f[d]/block_r[d]; - Lexicographic::IndexFromCoor(coor_c,sc,coarse->_rdimensions); + int sc; + Coordinate coor_c(_ndimension); + Coordinate coor_f(_ndimension); - // z = A x + y - coalescedWrite(fineZ_[sf],coarseA_(sc)*fineX_(sf)+fineY_(sf)); + Lexicographic::CoorFromIndex(coor_f,sf,fine->_rdimensions); + for(int d=0;d<_ndimension;d++) coor_c[d]=coor_f[d]/block_r[d]; + Lexicographic::IndexFromCoor(coor_c,sc,coarse->_rdimensions); - }); + // z = A x + y +#ifdef __CUDA_ARCH__ + typename vobj2::tensor_reduced::scalar_object cA; + typename vobj::scalar_object cAx; +#else + typename vobj2::tensor_reduced cA; + vobj cAx; +#endif + convertType(cA,TensorRemove(coarseA_(sc))); + auto prod = cA*fineX_(sf); + convertType(cAx,prod); + coalescedWrite(fineZ_[sf],cAx+fineY_(sf)); + + }); return; } + template + inline void blockInnerProductD(Lattice &CoarseInner, + const Lattice &fineX, + const Lattice &fineY) +{ + typedef iScalar dotp; + + GridBase *coarse(CoarseInner.Grid()); + GridBase *fine (fineX.Grid()); + + Lattice fine_inner(fine); fine_inner.Checkerboard() = fineX.Checkerboard(); + Lattice coarse_inner(coarse); + + auto CoarseInner_ = CoarseInner.AcceleratorView(ViewWrite); + auto coarse_inner_ = coarse_inner.AcceleratorView(ViewReadWrite); + + // Precision promotion + fine_inner = localInnerProductD(fineX,fineY); + blockSum(coarse_inner,fine_inner); + accelerator_for(ss, coarse->oSites(), 1, { + convertType(CoarseInner_[ss], TensorRemove(coarse_inner_[ss])); + }); + +} + +template // deprecate inline void blockInnerProduct(Lattice &CoarseInner, const Lattice &fineX, const Lattice &fineY) @@ -227,8 +370,8 @@ inline void blockInnerProduct(Lattice &CoarseInner, Lattice coarse_inner(coarse); // Precision promotion? - auto CoarseInner_ = CoarseInner.View(); - auto coarse_inner_ = coarse_inner.View(); + auto CoarseInner_ = CoarseInner.AcceleratorView(ViewWrite); + auto coarse_inner_ = coarse_inner.AcceleratorView(ViewReadWrite); fine_inner = localInnerProduct(fineX,fineY); blockSum(coarse_inner,fine_inner); @@ -236,6 +379,7 @@ inline void blockInnerProduct(Lattice &CoarseInner, CoarseInner_[ss] = coarse_inner_[ss]; }); } + template inline void blockNormalise(Lattice &ip,Lattice &fineX) { @@ -248,7 +392,7 @@ inline void blockNormalise(Lattice &ip,Lattice &fineX) // useful in multigrid project; // Generic name : Coarsen? template -inline void blockSum(Lattice &coarseData,const Lattice &fineData) +inline void blockSum(Lattice &coarseData,const Lattice &fineData) { GridBase * fine = fineData.Grid(); GridBase * coarse= coarseData.Grid(); @@ -256,42 +400,41 @@ inline void blockSum(Lattice &coarseData,const Lattice &fineData) subdivides(coarse,fine); // require they map int _ndimension = coarse->_ndimension; - + Coordinate block_r (_ndimension); - + for(int d=0 ; d<_ndimension;d++){ block_r[d] = fine->_rdimensions[d] / coarse->_rdimensions[d]; } int blockVol = fine->oSites()/coarse->oSites(); - // Turn this around to loop threaded over sc and interior loop - // over sf would thread better - auto coarseData_ = coarseData.View(); - auto fineData_ = fineData.View(); + auto coarseData_ = coarseData.AcceleratorView(ViewReadWrite); + auto fineData_ = fineData.AcceleratorView(ViewRead); accelerator_for(sc,coarse->oSites(),1,{ - // One thread per sub block - Coordinate coor_c(_ndimension); - Lexicographic::CoorFromIndex(coor_c,sc,coarse->_rdimensions); // Block coordinate - coarseData_[sc]=Zero(); + // One thread per sub block + Coordinate coor_c(_ndimension); + Lexicographic::CoorFromIndex(coor_c,sc,coarse->_rdimensions); // Block coordinate + coarseData_[sc]=Zero(); - for(int sb=0;sb_rdimensions); + for(int sb=0;sb_rdimensions); - }); + coarseData_[sc]=coarseData_[sc]+fineData_[sf]; + } + + }); return; } + template inline void blockPick(GridBase *coarse,const Lattice &unpicked,Lattice &picked,Coordinate coor) { @@ -313,8 +456,8 @@ inline void blockPick(GridBase *coarse,const Lattice &unpicked,Lattice -inline void blockOrthogonalise(Lattice &ip,std::vector > &Basis) +template +inline void blockOrthonormalize(Lattice &ip,VLattice &Basis) { GridBase *coarse = ip.Grid(); GridBase *fine = Basis[0].Grid(); @@ -322,23 +465,30 @@ inline void blockOrthogonalise(Lattice &ip,std::vector > int nbasis = Basis.size() ; // checks - subdivides(coarse,fine); + subdivides(coarse,fine); for(int i=0;i (Basis[v],ip,Basis[u],Basis[v]); + blockZAXPY(Basis[v],ip,Basis[u],Basis[v]); } blockNormalise(ip,Basis[v]); } } +template +inline void blockOrthogonalise(Lattice &ip,std::vector > &Basis) // deprecated inaccurate naming +{ + blockOrthonormalize(ip,Basis); +} + #if 0 +// TODO: CPU optimized version here template inline void blockPromote(const Lattice > &coarseData, Lattice &fineData, @@ -383,24 +533,18 @@ inline void blockPromote(const Lattice > &coarseData, } #else -template +template inline void blockPromote(const Lattice > &coarseData, Lattice &fineData, - const std::vector > &Basis) + const VLattice &Basis) { GridBase * fine = fineData.Grid(); GridBase * coarse= coarseData.Grid(); - fineData=Zero(); for(int i=0;i > ip = PeekIndex<0>(coarseData,i); - Lattice cip(coarse); - auto cip_ = cip.View(); - auto ip_ = ip.View(); - accelerator_forNB(sc,coarse->oSites(),CComplex::Nsimd(),{ - coalescedWrite(cip_[sc], ip_(sc)()); - }); - blockZAXPY(fineData,cip,Basis[i],fineData); + auto ip_ = ip.AcceleratorView(ViewRead); + blockZAXPY(fineData,ip,Basis[i],fineData); } } #endif @@ -470,8 +614,8 @@ void localCopyRegion(const Lattice &From,Lattice & To,Coordinate Fro Coordinate rdt = Tg->_rdimensions; Coordinate ist = Tg->_istride; Coordinate ost = Tg->_ostride; - auto t_v = To.View(); - auto f_v = From.View(); + auto t_v = To.AcceleratorView(ViewWrite); + auto f_v = From.AcceleratorView(ViewRead); accelerator_for(idx,Fg->lSites(),1,{ sobj s; Coordinate Fcoor(nd); From 87984ece7d135f236c671ab3caeaafd7beb4158f Mon Sep 17 00:00:00 2001 From: Christoph Lehner Date: Wed, 6 May 2020 08:47:18 -0400 Subject: [PATCH 36/36] add Lattice_basis.h --- Grid/lattice/Lattice_basis.h | 236 +++++++++++++++++++++++++++++++++++ 1 file changed, 236 insertions(+) create mode 100644 Grid/lattice/Lattice_basis.h diff --git a/Grid/lattice/Lattice_basis.h b/Grid/lattice/Lattice_basis.h new file mode 100644 index 00000000..f1126936 --- /dev/null +++ b/Grid/lattice/Lattice_basis.h @@ -0,0 +1,236 @@ +/************************************************************************************* + +Grid physics library, www.github.com/paboyle/Grid + +Source file: ./lib/lattice/Lattice_basis.h + +Copyright (C) 2015 + +Author: Peter Boyle +Author: paboyle +Author: Christoph Lehner + +This program is free software; you can redistribute it and/or modify +it under the terms of the GNU General Public License as published by +the Free Software Foundation; either version 2 of the License, or +(at your option) any later version. + +This program is distributed in the hope that it will be useful, +but WITHOUT ANY WARRANTY; without even the implied warranty of +MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the +GNU General Public License for more details. + +You should have received a copy of the GNU General Public License along +with this program; if not, write to the Free Software Foundation, Inc., +51 Franklin Street, Fifth Floor, Boston, MA 02110-1301 USA. + +See the full license in the file "LICENSE" in the top level distribution +directory +*************************************************************************************/ + /* END LEGAL */ + +#pragma once + +NAMESPACE_BEGIN(Grid); + +template +void basisOrthogonalize(std::vector &basis,Field &w,int k) +{ + // If assume basis[j] are already orthonormal, + // can take all inner products in parallel saving 2x bandwidth + // Save 3x bandwidth on the second line of loop. + // perhaps 2.5x speed up. + // 2x overall in Multigrid Lanczos + for(int j=0; j +void basisRotate(VField &basis,Matrix& Qt,int j0, int j1, int k0,int k1,int Nm) +{ + typedef decltype(basis[0]) Field; + typedef decltype(basis[0].View()) View; + auto tmp_v = basis[0].AcceleratorView(ViewReadWrite); + Vector basis_v(basis.size(),tmp_v); + typedef typename std::remove_reference::type vobj; + GridBase* grid = basis[0].Grid(); + + for(int k=0;k B(Nm); // Thread private + thread_for_in_region(ss, grid->oSites(),{ + for(int j=j0; joSites(); + uint64_t siteBlock=(grid->oSites()+nrot-1)/nrot; // Maximum 1 additional vector overhead + + Vector Bt(siteBlock * nrot); + auto Bp=&Bt[0]; + + // GPU readable copy of matrix + Vector Qt_jv(Nm*Nm); + double *Qt_p = & Qt_jv[0]; + thread_for(i,Nm*Nm,{ + int j = i/Nm; + int k = i%Nm; + Qt_p[i]=Qt(j,k); + }); + + // Block the loop to keep storage footprint down + for(uint64_t s=0;s +void basisRotateJ(Field &result,std::vector &basis,Eigen::MatrixXd& Qt,int j, int k0,int k1,int Nm) +{ + typedef decltype(basis[0].AcceleratorView()) View; + typedef typename Field::vector_object vobj; + GridBase* grid = basis[0].Grid(); + + result.Checkerboard() = basis[0].Checkerboard(); + auto result_v=result.AcceleratorView(ViewWrite); + Vector basis_v(basis.size(),result_v); + for(int k=0;k Qt_jv(Nm); + double * Qt_j = & Qt_jv[0]; + for(int k=0;koSites(),vobj::Nsimd(),{ + auto B=coalescedRead(zz); + for(int k=k0; k +void basisReorderInPlace(std::vector &_v,std::vector& sort_vals, std::vector& idx) +{ + int vlen = idx.size(); + + assert(vlen>=1); + assert(vlen<=sort_vals.size()); + assert(vlen<=_v.size()); + + for (size_t i=0;ii for which _vnew[j] = _vold[i], + // track the move idx[j] => idx[i] + // track the move idx[i] => i + ////////////////////////////////////// + size_t j; + for (j=i;j i); assert(j!=idx.size()); assert(idx[j]==i); + + swap(_v[i],_v[idx[i]]); // should use vector move constructor, no data copy + std::swap(sort_vals[i],sort_vals[idx[i]]); + + idx[j] = idx[i]; + idx[i] = i; + } + } +} + +inline std::vector basisSortGetIndex(std::vector& sort_vals) +{ + std::vector idx(sort_vals.size()); + std::iota(idx.begin(), idx.end(), 0); + + // sort indexes based on comparing values in v + std::sort(idx.begin(), idx.end(), [&sort_vals](int i1, int i2) { + return ::fabs(sort_vals[i1]) < ::fabs(sort_vals[i2]); + }); + return idx; +} + +template +void basisSortInPlace(std::vector & _v,std::vector& sort_vals, bool reverse) +{ + std::vector idx = basisSortGetIndex(sort_vals); + if (reverse) + std::reverse(idx.begin(), idx.end()); + + basisReorderInPlace(_v,sort_vals,idx); +} + +// PAB: faster to compute the inner products first then fuse loops. +// If performance critical can improve. +template +void basisDeflate(const std::vector &_v,const std::vector& eval,const Field& src_orig,Field& result) { + result = Zero(); + assert(_v.size()==eval.size()); + int N = (int)_v.size(); + for (int i=0;i