1
0
mirror of https://github.com/paboyle/Grid.git synced 2025-04-09 21:50:45 +01:00

Changes to A2Autils, A2AMatirx and DiskVector code that is needed for Hadrons 4 quark contraction module

This commit is contained in:
fionnoh 2019-06-27 13:45:20 +08:00
parent ac530636ca
commit 421a0a8a36
3 changed files with 290 additions and 142 deletions

View File

@ -68,8 +68,17 @@ public:
const std::vector<ComplexField> &emB1, const std::vector<ComplexField> &emB1,
int orthogdim, double *t_kernel = nullptr, double *t_gsum = nullptr); int orthogdim, double *t_kernel = nullptr, double *t_gsum = nullptr);
static void ContractWWVV(std::vector<PropagatorField> &WWVV, template <typename TensorType>
const Eigen::Tensor<ComplexD,3> &WW_sd, typename std::enable_if<std::is_same<Eigen::Tensor<ComplexD,3>, TensorType>::value, void>::type
static ContractWWVV(std::vector<PropagatorField> &WWVV,
const TensorType &WW_sd,
const FermionField *vs,
const FermionField *vd);
template <typename TensorType>
typename std::enable_if<!std::is_same<Eigen::Tensor<ComplexD,3>, TensorType>::value, void>::type
static ContractWWVV(std::vector<PropagatorField> &WWVV,
const TensorType &WW_sd,
const FermionField *vs, const FermionField *vs,
const FermionField *vd); const FermionField *vd);
@ -99,6 +108,11 @@ public:
const FermionField *vd, const FermionField *vd,
int orthogdim); int orthogdim);
#endif #endif
private:
inline static void OuterProductWWVV(std::vector<PropagatorField> &WWVV,
const vobj &lhs,
const vobj &rhs,
const int Ns, const int ss, const int t);
}; };
template <class FImpl> template <class FImpl>
@ -961,12 +975,15 @@ void A2Autils<FImpl>::AslashField(TensorType &mat,
// Take WW_sd v^dag_d (x) v_s // Take WW_sd v^dag_d (x) v_s
// //
template<class FImpl> template <class FImpl>
void A2Autils<FImpl>::ContractWWVV(std::vector<PropagatorField> &WWVV, template <typename TensorType>
const Eigen::Tensor<ComplexD,3> &WW_sd, typename std::enable_if<std::is_same<Eigen::Tensor<ComplexD,3>, TensorType>::value, void>::type
A2Autils<FImpl>::ContractWWVV(std::vector<PropagatorField> &WWVV,
const TensorType &WW_sd,
const FermionField *vs, const FermionField *vs,
const FermionField *vd) const FermionField *vd)
{ {
std::cout << "Start contraction" << std::endl;
GridBase *grid = vs[0]._grid; GridBase *grid = vs[0]._grid;
int nd = grid->_ndimension; int nd = grid->_ndimension;
@ -989,33 +1006,90 @@ void A2Autils<FImpl>::ContractWWVV(std::vector<PropagatorField> &WWVV,
vobj tmp2 = zero; vobj tmp2 = zero;
vobj tmp3 = zero; vobj tmp3 = zero;
for(int d=d_o;d<MIN(d_o+d_unroll,N_d);d++){ for(int d=d_o;d<MIN(d_o+d_unroll,N_d);d++){
Scalar_v coeff = WW_sd(t,s,d); Scalar_v coeff = WW_sd(t,s,d);
tmp3 = conjugate(vd[d]._odata[ss]); tmp3 = conjugate(vd[d]._odata[ss]);
mac(&tmp2, &coeff, &tmp3); mac(&tmp2 ,& coeff, &tmp3 );
} }
////////////////////////// //////////////////////////
// Fast outer product of tmp1 with a sum of terms suppressed by d_unroll // Fast outer product of tmp1 with a sum of terms suppressed by d_unroll
////////////////////////// //////////////////////////
for(int s1=0;s1<Ns;s1++){ OuterProductWWVV(WWVV, tmp1, tmp2, Ns, ss, t);
for(int s2=0;s2<Ns;s2++){
WWVV[t]._odata[ss]()(s1,s2)(0,0) += tmp1()(s1)(0)*tmp2()(s2)(0);
WWVV[t]._odata[ss]()(s1,s2)(0,1) += tmp1()(s1)(0)*tmp2()(s2)(1);
WWVV[t]._odata[ss]()(s1,s2)(0,2) += tmp1()(s1)(0)*tmp2()(s2)(2);
WWVV[t]._odata[ss]()(s1,s2)(1,0) += tmp1()(s1)(1)*tmp2()(s2)(0);
WWVV[t]._odata[ss]()(s1,s2)(1,1) += tmp1()(s1)(1)*tmp2()(s2)(1);
WWVV[t]._odata[ss]()(s1,s2)(1,2) += tmp1()(s1)(1)*tmp2()(s2)(2);
WWVV[t]._odata[ss]()(s1,s2)(2,0) += tmp1()(s1)(2)*tmp2()(s2)(0);
WWVV[t]._odata[ss]()(s1,s2)(2,1) += tmp1()(s1)(2)*tmp2()(s2)(1);
WWVV[t]._odata[ss]()(s1,s2)(2,2) += tmp1()(s1)(2)*tmp2()(s2)(2);
}}
}} }}
} }
} }
} }
template <class FImpl>
template <typename TensorType>
typename std::enable_if<!std::is_same<Eigen::Tensor<ComplexD,3>, TensorType>::value, void>::type
A2Autils<FImpl>::ContractWWVV(std::vector<PropagatorField> &WWVV,
const TensorType &WW_sd,
const FermionField *vs,
const FermionField *vd)
{
GridBase *grid = vs[0]._grid;
int nd = grid->_ndimension;
int Nsimd = grid->Nsimd();
int N_t = WW_sd.dimensions()[0];
int N_s = WW_sd.dimensions()[1];
int N_d = WW_sd.dimensions()[2];
int d_unroll = 32;// Empirical optimisation
Eigen::Matrix<Complex, -1, -1, Eigen::RowMajor> buf;
for(int t=0;t<N_t;t++){
WWVV[t] = zero;
}
for (int t = 0; t < N_t; t++){
std::cout << GridLogMessage << "Contraction t = " << t << std::endl;
buf = WW_sd[t];
parallel_for(int ss=0;ss<grid->oSites();ss++){
for(int d_o=0;d_o<N_d;d_o+=d_unroll){
for(int s=0;s<N_s;s++){
auto tmp1 = vs[s]._odata[ss];
vobj tmp2 = zero;
vobj tmp3 = zero;
for(int d=d_o;d<MIN(d_o+d_unroll,N_d);d++){
Scalar_v coeff = buf(s,d);
tmp3 = conjugate(vd[d]._odata[ss]);
mac(&tmp2 ,& coeff, &tmp3 );
}
//////////////////////////
// Fast outer product of tmp1 with a sum of terms suppressed by d_unroll
//////////////////////////
OuterProductWWVV(WWVV, tmp1, tmp2, Ns, ss, t);
}}
}
}
}
template <class FImpl>
inline void A2Autils<FImpl>::OuterProductWWVV(std::vector<PropagatorField> &WWVV,
const vobj &lhs,
const vobj &rhs,
const int Ns, const int ss, const int t)
{
for (int s1 = 0; s1 < Ns; s1++){
for (int s2 = 0; s2 < Ns; s2++){
WWVV[t]._odata[ss]()(s1, s2)(0, 0) += lhs()(s1)(0) * rhs()(s2)(0);
WWVV[t]._odata[ss]()(s1, s2)(0, 1) += lhs()(s1)(0) * rhs()(s2)(1);
WWVV[t]._odata[ss]()(s1, s2)(0, 2) += lhs()(s1)(0) * rhs()(s2)(2);
WWVV[t]._odata[ss]()(s1, s2)(1, 0) += lhs()(s1)(1) * rhs()(s2)(0);
WWVV[t]._odata[ss]()(s1, s2)(1, 1) += lhs()(s1)(1) * rhs()(s2)(1);
WWVV[t]._odata[ss]()(s1, s2)(1, 2) += lhs()(s1)(1) * rhs()(s2)(2);
WWVV[t]._odata[ss]()(s1, s2)(2, 0) += lhs()(s1)(2) * rhs()(s2)(0);
WWVV[t]._odata[ss]()(s1, s2)(2, 1) += lhs()(s1)(2) * rhs()(s2)(1);
WWVV[t]._odata[ss]()(s1, s2)(2, 2) += lhs()(s1)(2) * rhs()(s2)(2);
}
}
}
template<class FImpl> template<class FImpl>
void A2Autils<FImpl>::ContractFourQuarkColourDiagonal(const PropagatorField &WWVV0, void A2Autils<FImpl>::ContractFourQuarkColourDiagonal(const PropagatorField &WWVV0,

View File

@ -108,7 +108,7 @@ public:
void saveBlock(const A2AMatrixSet<T> &m, const unsigned int ext, const unsigned int str, void saveBlock(const A2AMatrixSet<T> &m, const unsigned int ext, const unsigned int str,
const unsigned int i, const unsigned int j); const unsigned int i, const unsigned int j);
template <template <class> class Vec, typename VecT> template <template <class> class Vec, typename VecT>
void load(Vec<VecT> &v, double *tRead = nullptr); void load(Vec<VecT> &v, double *tRead = nullptr, GridBase *grid = nullptr);
private: private:
std::string filename_{""}, dataname_{""}; std::string filename_{""}, dataname_{""};
unsigned int nt_{0}, ni_{0}, nj_{0}; unsigned int nt_{0}, ni_{0}, nj_{0};
@ -495,44 +495,53 @@ void A2AMatrixIo<T>::saveBlock(const A2AMatrixSet<T> &m,
template <typename T> template <typename T>
template <template <class> class Vec, typename VecT> template <template <class> class Vec, typename VecT>
void A2AMatrixIo<T>::load(Vec<VecT> &v, double *tRead) void A2AMatrixIo<T>::load(Vec<VecT> &v, double *tRead, GridBase *grid)
{ {
#ifdef HAVE_HDF5 #ifdef HAVE_HDF5
Hdf5Reader reader(filename_);
std::vector<hsize_t> hdim; std::vector<hsize_t> hdim;
H5NS::DataSet dataset; H5NS::DataSet dataset;
H5NS::DataSpace dataspace; H5NS::DataSpace dataspace;
H5NS::CompType datatype; H5NS::CompType datatype;
push(reader, dataname_); if (!(grid) || grid->IsBoss())
auto &group = reader.getGroup();
dataset = group.openDataSet(HADRONS_A2AM_NAME);
datatype = dataset.getCompType();
dataspace = dataset.getSpace();
hdim.resize(dataspace.getSimpleExtentNdims());
dataspace.getSimpleExtentDims(hdim.data());
if ((nt_*ni_*nj_ != 0) and
((hdim[0] != nt_) or (hdim[1] != ni_) or (hdim[2] != nj_)))
{ {
HADRONS_ERROR(Size, "all-to-all matrix size mismatch (got " Hdf5Reader reader(filename_);
+ std::to_string(hdim[0]) + "x" + std::to_string(hdim[1]) + "x" push(reader, dataname_);
+ std::to_string(hdim[2]) + ", expected " auto &group = reader.getGroup();
+ std::to_string(nt_) + "x" + std::to_string(ni_) + "x" dataset = group.openDataSet(HADRONS_A2AM_NAME);
+ std::to_string(nj_)); datatype = dataset.getCompType();
} dataspace = dataset.getSpace();
else if (ni_*nj_ == 0) hdim.resize(dataspace.getSimpleExtentNdims());
{ dataspace.getSimpleExtentDims(hdim.data());
if (hdim[0] != nt_) if ((nt_ * ni_ * nj_ != 0) and
((hdim[0] != nt_) or (hdim[1] != ni_) or (hdim[2] != nj_)))
{ {
HADRONS_ERROR(Size, "all-to-all time size mismatch (got " HADRONS_ERROR(Size, "all-to-all matrix size mismatch (got "
+ std::to_string(hdim[0]) + ", expected " + std::to_string(hdim[0]) + "x" + std::to_string(hdim[1]) + "x"
+ std::to_string(nt_) + ")"); + std::to_string(hdim[2]) + ", expected "
+ std::to_string(nt_) + "x" + std::to_string(ni_) + "x"
+ std::to_string(nj_));
} }
ni_ = hdim[1]; else if (ni_*nj_ == 0)
nj_ = hdim[2]; {
if (hdim[0] != nt_)
{
HADRONS_ERROR(Size, "all-to-all time size mismatch (got "
+ std::to_string(hdim[0]) + ", expected "
+ std::to_string(nt_) + ")");
}
ni_ = hdim[1];
nj_ = hdim[2];
}
}
if (grid)
{
grid->Broadcast(grid->BossRank(), &ni_, sizeof(unsigned int));
grid->Broadcast(grid->BossRank(), &nj_, sizeof(unsigned int));
} }
A2AMatrix<T> buf(ni_, nj_); A2AMatrix<T> buf(ni_, nj_);
int broadcastSize = sizeof(T) * buf.size();
std::vector<hsize_t> count = {1, static_cast<hsize_t>(ni_), std::vector<hsize_t> count = {1, static_cast<hsize_t>(ni_),
static_cast<hsize_t>(nj_)}, static_cast<hsize_t>(nj_)},
stride = {1, 1, 1}, stride = {1, 1, 1},
@ -554,10 +563,20 @@ void A2AMatrixIo<T>::load(Vec<VecT> &v, double *tRead)
std::cout << " " << t; std::cout << " " << t;
std::cout.flush(); std::cout.flush();
} }
dataspace.selectHyperslab(H5S_SELECT_SET, count.data(), offset.data(), if (!(grid) || grid->IsBoss())
stride.data(), block.data()); {
if (tRead) *tRead -= usecond(); dataspace.selectHyperslab(H5S_SELECT_SET, count.data(), offset.data(),
dataset.read(buf.data(), datatype, memspace, dataspace); stride.data(), block.data());
}
if (tRead) *tRead -= usecond();
if (!(grid) || grid->IsBoss())
{
dataset.read(buf.data(), datatype, memspace, dataspace);
}
if (grid)
{
grid->Broadcast(grid->BossRank(), buf.data(), broadcastSize);
}
if (tRead) *tRead += usecond(); if (tRead) *tRead += usecond();
v[t] = buf.template cast<VecT>(); v[t] = buf.template cast<VecT>();
} }

View File

@ -87,13 +87,20 @@ public:
}; };
public: public:
DiskVectorBase(const std::string dirname, const unsigned int size = 0, DiskVectorBase(const std::string dirname, const unsigned int size = 0,
const unsigned int cacheSize = 1, const bool clean = true); const unsigned int cacheSize = 1, const bool clean = true,
GridBase *grid = nullptr);
DiskVectorBase(DiskVectorBase<T> &&v) = default; DiskVectorBase(DiskVectorBase<T> &&v) = default;
virtual ~DiskVectorBase(void); virtual ~DiskVectorBase(void);
const T & operator[](const unsigned int i) const; const T & operator[](const unsigned int i) const;
RwAccessHelper operator[](const unsigned int i); RwAccessHelper operator[](const unsigned int i);
double hitRatio(void) const; double hitRatio(void) const;
void resetStat(void); void resetStat(void);
void setSize(unsigned int size_);
unsigned int getSize() const;
unsigned int dvSize;
void setGrid(GridBase *grid_);
GridBase *getGrid() const;
GridBase *dvGrid;
private: private:
virtual void load(T &obj, const std::string filename) const = 0; virtual void load(T &obj, const std::string filename) const = 0;
virtual void save(const std::string filename, const T &obj) const = 0; virtual void save(const std::string filename, const T &obj) const = 0;
@ -107,6 +114,7 @@ private:
unsigned int size_, cacheSize_; unsigned int size_, cacheSize_;
double access_{0.}, hit_{0.}; double access_{0.}, hit_{0.};
bool clean_; bool clean_;
GridBase *grid_;
// using pointers to allow modifications when class is const // using pointers to allow modifications when class is const
// semantic: const means data unmodified, but cache modification allowed // semantic: const means data unmodified, but cache modification allowed
std::unique_ptr<std::vector<T>> cachePtr_; std::unique_ptr<std::vector<T>> cachePtr_;
@ -158,66 +166,92 @@ public:
{ {
return (*this)[i](j, k); return (*this)[i](j, k);
} }
std::vector<int> dimensions() const
{
std::vector<int> dims(3);
dims[0] = (*this).getSize();
dims[1] = (*this)[0].rows();
dims[2] = (*this)[0].cols();
return dims;
}
private: private:
virtual void load(EigenDiskVectorMat<T> &obj, const std::string filename) const virtual void load(EigenDiskVectorMat<T> &obj, const std::string filename) const
{ {
std::ifstream f(filename, std::ios::binary); GridBase *loadGrid;
uint32_t crc, check; loadGrid = (*this).getGrid();
Eigen::Index nRow, nCol; if (!(loadGrid) || loadGrid->IsBoss())
size_t matSize;
double tRead, tHash;
f.read(reinterpret_cast<char *>(&crc), sizeof(crc));
f.read(reinterpret_cast<char *>(&nRow), sizeof(nRow));
f.read(reinterpret_cast<char *>(&nCol), sizeof(nCol));
obj.resize(nRow, nCol);
matSize = nRow*nCol*sizeof(T);
tRead = -usecond();
f.read(reinterpret_cast<char *>(obj.data()), matSize);
tRead += usecond();
tHash = -usecond();
#ifdef USE_IPP
check = GridChecksum::crc32c(obj.data(), matSize);
#else
check = GridChecksum::crc32(obj.data(), matSize);
#endif
tHash += usecond();
DV_DEBUG_MSG(this, "Eigen read " << tRead/1.0e6 << " sec " << matSize/tRead*1.0e6/1024/1024 << " MB/s");
DV_DEBUG_MSG(this, "Eigen crc32 " << std::hex << check << std::dec
<< " " << tHash/1.0e6 << " sec " << matSize/tHash*1.0e6/1024/1024 << " MB/s");
if (crc != check)
{ {
HADRONS_ERROR(Io, "checksum failed") std::ifstream f(filename, std::ios::binary);
uint32_t crc, check;
Eigen::Index nRow, nCol;
size_t matSize;
double tRead, tHash;
f.read(reinterpret_cast<char *>(&crc), sizeof(crc));
f.read(reinterpret_cast<char *>(&nRow), sizeof(nRow));
f.read(reinterpret_cast<char *>(&nCol), sizeof(nCol));
obj.resize(nRow, nCol);
matSize = nRow*nCol*sizeof(T);
tRead = -usecond();
f.read(reinterpret_cast<char *>(obj.data()), matSize);
tRead += usecond();
tHash = -usecond();
#ifdef USE_IPP
check = GridChecksum::crc32c(obj.data(), matSize);
#else
check = GridChecksum::crc32(obj.data(), matSize);
#endif
tHash += usecond();
DV_DEBUG_MSG(this, "Eigen read " << tRead/1.0e6 << " sec " << matSize/tRead*1.0e6/1024/1024 << " MB/s");
DV_DEBUG_MSG(this, "Eigen crc32 " << std::hex << check << std::dec
<< " " << tHash/1.0e6 << " sec " << matSize/tHash*1.0e6/1024/1024 << " MB/s");
if (crc != check)
{
HADRONS_ERROR(Io, "checksum failed")
}
}
int broadcastSize;
broadcastSize = sizeof(T)*obj.size();
if (loadGrid)
{
loadGrid->Broadcast(loadGrid->BossRank(), obj.data(), broadcastSize);
loadGrid->Barrier();
} }
} }
virtual void save(const std::string filename, const EigenDiskVectorMat<T> &obj) const virtual void save(const std::string filename, const EigenDiskVectorMat<T> &obj) const
{ {
std::ofstream f(filename, std::ios::binary); GridBase *saveGrid;
uint32_t crc; saveGrid = (*this).getGrid();
Eigen::Index nRow, nCol; if (!(saveGrid) || saveGrid->IsBoss())
size_t matSize; {
double tWrite, tHash; std::ofstream f(filename, std::ios::binary);
uint32_t crc;
nRow = obj.rows(); Eigen::Index nRow, nCol;
nCol = obj.cols(); size_t matSize;
matSize = nRow*nCol*sizeof(T); double tWrite, tHash;
tHash = -usecond();
#ifdef USE_IPP nRow = obj.rows();
crc = GridChecksum::crc32c(obj.data(), matSize); nCol = obj.cols();
#else matSize = nRow*nCol*sizeof(T);
crc = GridChecksum::crc32(obj.data(), matSize); tHash = -usecond();
#endif #ifdef USE_IPP
tHash += usecond(); crc = GridChecksum::crc32c(obj.data(), matSize);
f.write(reinterpret_cast<char *>(&crc), sizeof(crc)); #else
f.write(reinterpret_cast<char *>(&nRow), sizeof(nRow)); crc = GridChecksum::crc32(obj.data(), matSize);
f.write(reinterpret_cast<char *>(&nCol), sizeof(nCol)); #endif
tWrite = -usecond(); tHash += usecond();
f.write(reinterpret_cast<const char *>(obj.data()), matSize); f.write(reinterpret_cast<char *>(&crc), sizeof(crc));
tWrite += usecond(); f.write(reinterpret_cast<char *>(&nRow), sizeof(nRow));
DV_DEBUG_MSG(this, "Eigen write " << tWrite/1.0e6 << " sec " << matSize/tWrite*1.0e6/1024/1024 << " MB/s"); f.write(reinterpret_cast<char *>(&nCol), sizeof(nCol));
DV_DEBUG_MSG(this, "Eigen crc32 " << std::hex << crc << std::dec tWrite = -usecond();
<< " " << tHash/1.0e6 << " sec " << matSize/tHash*1.0e6/1024/1024 << " MB/s"); f.write(reinterpret_cast<const char *>(obj.data()), matSize);
tWrite += usecond();
DV_DEBUG_MSG(this, "Eigen write " << tWrite/1.0e6 << " sec " << matSize/tWrite*1.0e6/1024/1024 << " MB/s");
DV_DEBUG_MSG(this, "Eigen crc32 " << std::hex << crc << std::dec
<< " " << tHash/1.0e6 << " sec " << matSize/tHash*1.0e6/1024/1024 << " MB/s");
}
if (saveGrid) saveGrid->Barrier();
} }
}; };
@ -228,8 +262,9 @@ template <typename T>
DiskVectorBase<T>::DiskVectorBase(const std::string dirname, DiskVectorBase<T>::DiskVectorBase(const std::string dirname,
const unsigned int size, const unsigned int size,
const unsigned int cacheSize, const unsigned int cacheSize,
const bool clean) const bool clean,
: dirname_(dirname), size_(size), cacheSize_(cacheSize), clean_(clean) GridBase *grid)
: dirname_(dirname), size_(size), cacheSize_(cacheSize), clean_(clean), grid_(grid)
, cachePtr_(new std::vector<T>(size)) , cachePtr_(new std::vector<T>(size))
, modifiedPtr_(new std::vector<bool>(size, false)) , modifiedPtr_(new std::vector<bool>(size, false))
, indexPtr_(new std::map<unsigned int, unsigned int>()) , indexPtr_(new std::map<unsigned int, unsigned int>())
@ -238,15 +273,21 @@ DiskVectorBase<T>::DiskVectorBase(const std::string dirname,
{ {
struct stat s; struct stat s;
if(stat(dirname.c_str(), &s) == 0) if (!(grid_) || grid_->IsBoss())
{ {
HADRONS_ERROR(Io, "directory '" + dirname + "' already exists") if(stat(dirname.c_str(), &s) == 0)
{
HADRONS_ERROR(Io, "directory '" + dirname + "' already exists")
}
mkdir(dirname);
} }
mkdir(dirname); if (grid_) grid_->Barrier();
for (unsigned int i = 0; i < cacheSize_; ++i) for (unsigned int i = 0; i < cacheSize_; ++i)
{ {
freePtr_->push(i); freePtr_->push(i);
} }
setSize(size_);
setGrid(grid_);
} }
template <typename T> template <typename T>
@ -258,6 +299,30 @@ DiskVectorBase<T>::~DiskVectorBase(void)
} }
} }
template <typename T>
void DiskVectorBase<T>::setSize(unsigned int size_)
{
dvSize = size_;
}
template <typename T>
unsigned int DiskVectorBase<T>::getSize() const
{
return dvSize;
}
template <typename T>
void DiskVectorBase<T>::setGrid(GridBase *grid_)
{
dvGrid = grid_;
}
template <typename T>
GridBase *DiskVectorBase<T>::getGrid() const
{
return dvGrid;
}
template <typename T> template <typename T>
const T & DiskVectorBase<T>::operator[](const unsigned int i) const const T & DiskVectorBase<T>::operator[](const unsigned int i) const
{ {
@ -299,7 +364,7 @@ const T & DiskVectorBase<T>::operator[](const unsigned int i) const
} }
DV_DEBUG_MSG(this, "in cache: " << msg); DV_DEBUG_MSG(this, "in cache: " << msg);
#endif #endif
if (grid_) grid_->Barrier();
return cache[index.at(i)]; return cache[index.at(i)];
} }
@ -358,6 +423,7 @@ void DiskVectorBase<T>::evict(void) const
index.erase(i); index.erase(i);
loads.pop_front(); loads.pop_front();
} }
if (grid_) grid_->Barrier();
} }
template <typename T> template <typename T>
@ -395,27 +461,14 @@ void DiskVectorBase<T>::cacheInsert(const unsigned int i, const T &obj) const
auto &freeInd = *freePtr_; auto &freeInd = *freePtr_;
auto &loads = *loadsPtr_; auto &loads = *loadsPtr_;
// cache miss, evict and store evict();
if (index.find(i) == index.end()) index[i] = freeInd.top();
{ freeInd.pop();
evict(); cache[index.at(i)] = obj;
index[i] = freeInd.top(); loads.push_back(i);
freeInd.pop(); modified[index.at(i)] = false;
cache[index.at(i)] = obj;
loads.push_back(i);
modified[index.at(i)] = false;
}
// cache hit, modify current value
else
{
auto pos = std::find(loads.begin(), loads.end(), i);
cache[index.at(i)] = obj;
modified[index.at(i)] = true;
loads.erase(pos);
loads.push_back(i);
}
if (grid_) grid_->Barrier();
#ifdef DV_DEBUG #ifdef DV_DEBUG
std::string msg; std::string msg;
@ -434,21 +487,23 @@ void DiskVectorBase<T>::cacheInsert(const unsigned int i, const T &obj) const
template <typename T> template <typename T>
void DiskVectorBase<T>::clean(void) void DiskVectorBase<T>::clean(void)
{ {
auto unlink = [](const char *fpath, const struct stat *sb, if (!(grid_) || grid_->IsBoss())
int typeflag, struct FTW *ftwbuf)
{ {
int rv = remove(fpath); auto unlink = [](const char *fpath, const struct stat *sb,
int typeflag, struct FTW *ftwbuf) {
int rv = remove(fpath);
if (rv) if (rv)
{ {
HADRONS_ERROR(Io, "cannot remove '" + std::string(fpath) + "': " HADRONS_ERROR(Io, "cannot remove '" + std::string(fpath) + "': " + std::string(std::strerror(errno)));
+ std::string(std::strerror(errno))); }
}
return rv; return rv;
}; };
nftw(dirname_.c_str(), unlink, 64, FTW_DEPTH | FTW_PHYS); nftw(dirname_.c_str(), unlink, 64, FTW_DEPTH | FTW_PHYS);
}
if (grid_) grid_->Barrier();
} }
END_HADRONS_NAMESPACE END_HADRONS_NAMESPACE