QMCPACK
PWOrbitalSet Class Reference
+ Inheritance diagram for PWOrbitalSet:
+ Collaboration diagram for PWOrbitalSet:

Public Types

enum  {
  PW_VALUE = BasisSet_t::PW_VALUE, PW_LAP = BasisSet_t::PW_LAP, PW_GRADX = BasisSet_t::PW_GRADX, PW_GRADY = BasisSet_t::PW_GRADY,
  PW_GRADZ = BasisSet_t::PW_GRADZ, PW_MAXINDEX = BasisSet_t::PW_MAXINDEX
}
 inherit the enum of BasisSet_t More...
 
using BasisSet_t = PWBasis
 
using PWBasisPtr = PWBasis *
 
- Public Types inherited from SPOSet
using ValueVector = OrbitalSetTraits< ValueType >::ValueVector
 
using ValueMatrix = OrbitalSetTraits< ValueType >::ValueMatrix
 
using GradVector = OrbitalSetTraits< ValueType >::GradVector
 
using GradMatrix = OrbitalSetTraits< ValueType >::GradMatrix
 
using HessVector = OrbitalSetTraits< ValueType >::HessVector
 
using HessMatrix = OrbitalSetTraits< ValueType >::HessMatrix
 
using GGGVector = OrbitalSetTraits< ValueType >::GradHessVector
 
using GGGMatrix = OrbitalSetTraits< ValueType >::GradHessMatrix
 
using SPOMap = std::map< std::string, const std::unique_ptr< const SPOSet > >
 
using OffloadMWVGLArray = Array< ValueType, 3, OffloadPinnedAllocator< ValueType > >
 
using OffloadMWVArray = Array< ValueType, 2, OffloadPinnedAllocator< ValueType > >
 
template<typename DT >
using OffloadMatrix = Matrix< DT, OffloadPinnedAllocator< DT > >
 
- Public Types inherited from QMCTraits
enum  { DIM = OHMMS_DIM, DIM_VGL = OHMMS_DIM + 2 }
 
using QTBase = QMCTypes< OHMMS_PRECISION, DIM >
 
using QTFull = QMCTypes< OHMMS_PRECISION_FULL, DIM >
 
using RealType = QTBase::RealType
 
using ComplexType = QTBase::ComplexType
 
using ValueType = QTBase::ValueType
 
using PosType = QTBase::PosType
 
using GradType = QTBase::GradType
 
using TensorType = QTBase::TensorType
 
using IndexType = OHMMS_INDEXTYPE
 define other types More...
 
using FullPrecRealType = QTFull::RealType
 
using FullPrecValueType = QTFull::ValueType
 
using PropertySetType = RecordNamedProperty< FullPrecRealType >
 define PropertyList_t More...
 
using PtclGrpIndexes = std::vector< std::pair< int, int > >
 

Public Member Functions

 PWOrbitalSet (const std::string &my_name)
 default constructor More...
 
std::string getClassName () const override
 return class name More...
 
 ~PWOrbitalSet () override
 delete BasisSet only it owns this More...
 
std::unique_ptr< SPOSetmakeClone () const override
 make a clone of itself every derived class must implement this to have threading working correctly. More...
 
void resize (PWBasisPtr bset, int nbands, bool cleanup=false)
 resize the orbital base More...
 
void addVector (const std::vector< ComplexType > &coefs, int jorb)
 Builder class takes care of the assertion. More...
 
void addVector (const std::vector< RealType > &coefs, int jorb)
 
void setOrbitalSetSize (int norbs) override
 set the OrbitalSetSize More...
 
ValueType evaluate (int ib, const PosType &pos)
 
void evaluateValue (const ParticleSet &P, int iat, ValueVector &psi) override
 evaluate the values of this single-particle orbital set More...
 
void evaluateVGL (const ParticleSet &P, int iat, ValueVector &psi, GradVector &dpsi, ValueVector &d2psi) override
 evaluate the values, gradients and laplacians of this single-particle orbital set More...
 
void evaluate_notranspose (const ParticleSet &P, int first, int last, ValueMatrix &logdet, GradMatrix &dlogdet, ValueMatrix &d2logdet) override
 evaluate the values, gradients and laplacians of this single-particle orbital for [first,last) particles More...
 
- Public Member Functions inherited from SPOSet
 SPOSet (const std::string &my_name)
 constructor More...
 
virtual ~SPOSet ()=default
 destructor More...
 
int size () const
 return the size of the orbital set Ye: this needs to be replaced by getOrbitalSetSize(); More...
 
void basic_report (const std::string &pad="") const
 print basic SPOSet information More...
 
virtual void report (const std::string &pad="") const
 print SPOSet information More...
 
int getOrbitalSetSize () const
 return the size of the orbitals More...
 
virtual bool isOptimizable () const
 Query if this SPOSet is optimizable. More...
 
virtual void extractOptimizableObjectRefs (UniqueOptObjRefs &opt_obj_refs)
 extract underlying OptimizableObject references More...
 
virtual void checkOutVariables (const opt_variables_type &active)
 check out variational optimizable variables More...
 
virtual bool isOMPoffload () const
 Query if this SPOSet uses OpenMP offload. More...
 
virtual bool hasIonDerivs () const
 Query if this SPOSet has an explicit ion dependence. More...
 
virtual void checkObject () const
 check a few key parameters before putting the SPO into a determinant More...
 
virtual bool isRotationSupported () const
 return true if this SPOSet can be wrappered by RotatedSPO More...
 
virtual void storeParamsBeforeRotation ()
 store parameters before getting destroyed by rotation. More...
 
virtual void applyRotation (const ValueMatrix &rot_mat, bool use_stored_copy=false)
 apply rotation to all the orbitals More...
 
virtual void evaluateDerivatives (ParticleSet &P, const opt_variables_type &optvars, Vector< ValueType > &dlogpsi, Vector< ValueType > &dhpsioverpsi, const int &FirstIndex, const int &LastIndex)
 Parameter derivatives of the wavefunction and the Laplacian of the wavefunction. More...
 
virtual void evaluateDerivativesWF (ParticleSet &P, const opt_variables_type &optvars, Vector< ValueType > &dlogpsi, int FirstIndex, int LastIndex)
 Parameter derivatives of the wavefunction. More...
 
virtual void evaluateDerivatives (ParticleSet &P, const opt_variables_type &optvars, Vector< ValueType > &dlogpsi, Vector< ValueType > &dhpsioverpsi, const ValueType &psiCurrent, const std::vector< ValueType > &Coeff, const std::vector< size_t > &C2node_up, const std::vector< size_t > &C2node_dn, const ValueVector &detValues_up, const ValueVector &detValues_dn, const GradMatrix &grads_up, const GradMatrix &grads_dn, const ValueMatrix &lapls_up, const ValueMatrix &lapls_dn, const ValueMatrix &M_up, const ValueMatrix &M_dn, const ValueMatrix &Minv_up, const ValueMatrix &Minv_dn, const GradMatrix &B_grad, const ValueMatrix &B_lapl, const std::vector< int > &detData_up, const size_t N1, const size_t N2, const size_t NP1, const size_t NP2, const std::vector< std::vector< int >> &lookup_tbl)
 Evaluate the derivative of the optimized orbitals with respect to the parameters this is used only for MSD, to be refined for better serving both single and multi SD. More...
 
virtual void evaluateDerivativesWF (ParticleSet &P, const opt_variables_type &optvars, Vector< ValueType > &dlogpsi, const QTFull::ValueType &psiCurrent, const std::vector< ValueType > &Coeff, const std::vector< size_t > &C2node_up, const std::vector< size_t > &C2node_dn, const ValueVector &detValues_up, const ValueVector &detValues_dn, const ValueMatrix &M_up, const ValueMatrix &M_dn, const ValueMatrix &Minv_up, const ValueMatrix &Minv_dn, const std::vector< int > &detData_up, const std::vector< std::vector< int >> &lookup_tbl)
 Evaluate the derivative of the optimized orbitals with respect to the parameters this is used only for MSD, to be refined for better serving both single and multi SD. More...
 
virtual void evaluateDetRatios (const VirtualParticleSet &VP, ValueVector &psi, const ValueVector &psiinv, std::vector< ValueType > &ratios)
 evaluate determinant ratios for virtual moves, e.g., sphere move for nonlocalPP More...
 
virtual void evaluateDetSpinorRatios (const VirtualParticleSet &VP, ValueVector &psi, const std::pair< ValueVector, ValueVector > &spinor_multiplier, const ValueVector &invrow, std::vector< ValueType > &ratios)
 evaluate determinant ratios for virtual moves, specifically for Spinor SPOSets More...
 
virtual void evaluateDerivRatios (const VirtualParticleSet &VP, const opt_variables_type &optvars, ValueVector &psi, const ValueVector &psiinv, std::vector< ValueType > &ratios, Matrix< ValueType > &dratios, int FirstIndex, int LastIndex)
 Determinant ratios and parameter derivatives of the wavefunction for virtual moves. More...
 
virtual void mw_evaluateDetRatios (const RefVectorWithLeader< SPOSet > &spo_list, const RefVectorWithLeader< const VirtualParticleSet > &vp_list, const RefVector< ValueVector > &psi_list, const std::vector< const ValueType *> &invRow_ptr_list, std::vector< std::vector< ValueType >> &ratios_list) const
 evaluate determinant ratios for virtual moves, e.g., sphere move for nonlocalPP, of multiple walkers More...
 
virtual void evaluateVGL_spin (const ParticleSet &P, int iat, ValueVector &psi, GradVector &dpsi, ValueVector &d2psi, ValueVector &dspin)
 evaluate the values, gradients and laplacians and spin gradient of this single-particle orbital set More...
 
virtual void mw_evaluateValue (const RefVectorWithLeader< SPOSet > &spo_list, const RefVectorWithLeader< ParticleSet > &P_list, int iat, const RefVector< ValueVector > &psi_v_list) const
 evaluate the values this single-particle orbital sets of multiple walkers More...
 
virtual void mw_evaluateVGL (const RefVectorWithLeader< SPOSet > &spo_list, const RefVectorWithLeader< ParticleSet > &P_list, int iat, const RefVector< ValueVector > &psi_v_list, const RefVector< GradVector > &dpsi_v_list, const RefVector< ValueVector > &d2psi_v_list) const
 evaluate the values, gradients and laplacians of this single-particle orbital sets of multiple walkers More...
 
virtual void mw_evaluateVGLWithSpin (const RefVectorWithLeader< SPOSet > &spo_list, const RefVectorWithLeader< ParticleSet > &P_list, int iat, const RefVector< ValueVector > &psi_v_list, const RefVector< GradVector > &dpsi_v_list, const RefVector< ValueVector > &d2psi_v_list, OffloadMatrix< ComplexType > &mw_dspin) const
 evaluate the values, gradients and laplacians and spin gradient of this single-particle orbital sets of multiple walkers More...
 
virtual void mw_evaluateVGLandDetRatioGrads (const RefVectorWithLeader< SPOSet > &spo_list, const RefVectorWithLeader< ParticleSet > &P_list, int iat, const std::vector< const ValueType *> &invRow_ptr_list, OffloadMWVGLArray &phi_vgl_v, std::vector< ValueType > &ratios, std::vector< GradType > &grads) const
 evaluate the values, gradients and laplacians of this single-particle orbital sets and determinant ratio and grads of multiple walkers. More...
 
virtual void mw_evaluateVGLandDetRatioGradsWithSpin (const RefVectorWithLeader< SPOSet > &spo_list, const RefVectorWithLeader< ParticleSet > &P_list, int iat, const std::vector< const ValueType *> &invRow_ptr_list, OffloadMWVGLArray &phi_vgl_v, std::vector< ValueType > &ratios, std::vector< GradType > &grads, std::vector< ValueType > &spingrads) const
 evaluate the values, gradients and laplacians of this single-particle orbital sets and determinant ratio and grads of multiple walkers. More...
 
virtual void evaluateVGH (const ParticleSet &P, int iat, ValueVector &psi, GradVector &dpsi, HessVector &grad_grad_psi)
 evaluate the values, gradients and hessians of this single-particle orbital set More...
 
virtual void evaluateVGHGH (const ParticleSet &P, int iat, ValueVector &psi, GradVector &dpsi, HessVector &grad_grad_psi, GGGVector &grad_grad_grad_psi)
 evaluate the values, gradients, hessians, and grad hessians of this single-particle orbital set More...
 
virtual void evaluate_spin (const ParticleSet &P, int iat, ValueVector &psi, ValueVector &dpsi)
 evaluate the values of this single-particle orbital set More...
 
virtual void evaluateThirdDeriv (const ParticleSet &P, int first, int last, GGGMatrix &grad_grad_grad_logdet)
 evaluate the third derivatives of this single-particle orbital set More...
 
virtual void evaluate_notranspose_spin (const ParticleSet &P, int first, int last, ValueMatrix &logdet, GradMatrix &dlogdet, ValueMatrix &d2logdet, ValueMatrix &dspinlogdet)
 evaluate the values, gradients and laplacians of this single-particle orbital for [first,last) particles, including the spin gradient More...
 
virtual void mw_evaluate_notranspose (const RefVectorWithLeader< SPOSet > &spo_list, const RefVectorWithLeader< ParticleSet > &P_list, int first, int last, const RefVector< ValueMatrix > &logdet_list, const RefVector< GradMatrix > &dlogdet_list, const RefVector< ValueMatrix > &d2logdet_list) const
 
virtual void evaluate_notranspose (const ParticleSet &P, int first, int last, ValueMatrix &logdet, GradMatrix &dlogdet, HessMatrix &grad_grad_logdet)
 evaluate the values, gradients and hessians of this single-particle orbital for [first,last) particles More...
 
virtual void evaluate_notranspose (const ParticleSet &P, int first, int last, ValueMatrix &logdet, GradMatrix &dlogdet, HessMatrix &grad_grad_logdet, GGGMatrix &grad_grad_grad_logdet)
 evaluate the values, gradients, hessians and third derivatives of this single-particle orbital for [first,last) particles More...
 
virtual void evaluateGradSource (const ParticleSet &P, int first, int last, const ParticleSet &source, int iat_src, GradMatrix &gradphi)
 evaluate the gradients of this single-particle orbital for [first,last) target particles with respect to the given source particle More...
 
virtual void evaluateGradSource (const ParticleSet &P, int first, int last, const ParticleSet &source, int iat_src, GradMatrix &grad_phi, HessMatrix &grad_grad_phi, GradMatrix &grad_lapl_phi)
 evaluate the gradients of values, gradients, laplacians of this single-particle orbital for [first,last) target particles with respect to the given source particle More...
 
virtual void evaluateGradSourceRow (const ParticleSet &P, int iel, const ParticleSet &source, int iat_src, GradVector &gradphi)
 Returns a row of d/dR_iat phi_j(r) evaluated at position r. More...
 
virtual PosType get_k (int orb)
 access the k point related to the given orbital More...
 
virtual void createResource (ResourceCollection &collection) const
 initialize a shared resource and hand it to collection More...
 
virtual void acquireResource (ResourceCollection &collection, const RefVectorWithLeader< SPOSet > &spo_list) const
 acquire a shared resource from collection More...
 
virtual void releaseResource (ResourceCollection &collection, const RefVectorWithLeader< SPOSet > &spo_list) const
 return a shared resource to collection More...
 
virtual bool transformSPOSet ()
 Used only by cusp correction in AOS LCAO. More...
 
virtual void finalizeConstruction ()
 finalize the construction of SPOSet More...
 
const std::string & getName () const
 return object name More...
 

Public Attributes

bool OwnBasisSet
 boolean More...
 
PosType TwistAngle
 TwistAngle of this PWOrbitalSet. More...
 
PWBasisPtr myBasisSet
 My basis set. More...
 
IndexType BasisSetSize
 number of basis More...
 
ValueMatrixC
 pointer to matrix containing the coefficients More...
 
bool IsCloned
 if true, do not clean up More...
 
Matrix< ValueTypeTemp
 temporary array to perform gemm operation More...
 

Additional Inherited Members

- Protected Attributes inherited from SPOSet
const std::string my_name_
 name of the object, unique identifier More...
 
IndexType OrbitalSetSize
 number of Single-particle orbitals More...
 
opt_variables_type myVars
 Optimizable variables. More...
 

Detailed Description

Definition at line 27 of file PWOrbitalSet.h.

Member Typedef Documentation

◆ BasisSet_t

Definition at line 30 of file PWOrbitalSet.h.

◆ PWBasisPtr

using PWBasisPtr = PWBasis*

Definition at line 31 of file PWOrbitalSet.h.

Member Enumeration Documentation

◆ anonymous enum

Constructor & Destructor Documentation

◆ PWOrbitalSet()

PWOrbitalSet ( const std::string &  my_name)
inline

default constructor

Definition at line 46 of file PWOrbitalSet.h.

47  : SPOSet(my_name), OwnBasisSet(false), myBasisSet(nullptr), BasisSetSize(0), C(nullptr), IsCloned(false)
48  {}
SPOSet(const std::string &my_name)
constructor
Definition: SPOSet.cpp:29
IndexType BasisSetSize
number of basis
Definition: PWOrbitalSet.h:101
ValueMatrix * C
pointer to matrix containing the coefficients
Definition: PWOrbitalSet.h:106
PWBasisPtr myBasisSet
My basis set.
Definition: PWOrbitalSet.h:99
bool IsCloned
if true, do not clean up
Definition: PWOrbitalSet.h:108

◆ ~PWOrbitalSet()

~PWOrbitalSet ( )
override

delete BasisSet only it owns this

Builder takes care of who owns what

Definition at line 22 of file PWOrbitalSet.cpp.

References PWOrbitalSet::C, PWOrbitalSet::IsCloned, PWOrbitalSet::myBasisSet, and PWOrbitalSet::OwnBasisSet.

23 {
24  if (OwnBasisSet && myBasisSet)
25  delete myBasisSet;
26  if (!IsCloned && C != nullptr)
27  delete C;
28 }
ValueMatrix * C
pointer to matrix containing the coefficients
Definition: PWOrbitalSet.h:106
PWBasisPtr myBasisSet
My basis set.
Definition: PWOrbitalSet.h:99
bool IsCloned
if true, do not clean up
Definition: PWOrbitalSet.h:108

Member Function Documentation

◆ addVector() [1/2]

void addVector ( const std::vector< ComplexType > &  coefs,
int  jorb 
)

Builder class takes care of the assertion.

Definition at line 52 of file PWOrbitalSet.cpp.

References Communicate::abort(), qmcplusplus::app_error(), OHMMS::Controller, PWBasis::inputmap, and PWOrbitalSet::myBasisSet.

53 {
54  int ng = myBasisSet->inputmap.size();
55  if (ng != coefs.size())
56  {
57  app_error() << " Input G map does not match the basis size of wave functions " << std::endl;
59  }
60  //drop G points for the given TwistAngle
61  const std::vector<int>& inputmap(myBasisSet->inputmap);
62  for (int ig = 0; ig < ng; ig++)
63  {
64  if (inputmap[ig] > -1)
65  (*C)[jorb][inputmap[ig]] = coefs[ig];
66  }
67 }
std::ostream & app_error()
Definition: OutputManager.h:67
Communicate * Controller
Global Communicator for a process.
Definition: Communicate.cpp:35
PWBasisPtr myBasisSet
My basis set.
Definition: PWOrbitalSet.h:99
void abort() const
std::vector< int > inputmap
Definition: PWBasis.h:108

◆ addVector() [2/2]

void addVector ( const std::vector< RealType > &  coefs,
int  jorb 
)

Definition at line 69 of file PWOrbitalSet.cpp.

References Communicate::abort(), qmcplusplus::app_error(), OHMMS::Controller, PWBasis::inputmap, and PWOrbitalSet::myBasisSet.

70 {
71  int ng = myBasisSet->inputmap.size();
72  if (ng != coefs.size())
73  {
74  app_error() << " Input G map does not match the basis size of wave functions " << std::endl;
76  }
77  //drop G points for the given TwistAngle
78  const std::vector<int>& inputmap(myBasisSet->inputmap);
79  for (int ig = 0; ig < ng; ig++)
80  {
81  if (inputmap[ig] > -1)
82  (*C)[jorb][inputmap[ig]] = coefs[ig];
83  }
84 }
std::ostream & app_error()
Definition: OutputManager.h:67
Communicate * Controller
Global Communicator for a process.
Definition: Communicate.cpp:35
PWBasisPtr myBasisSet
My basis set.
Definition: PWOrbitalSet.h:99
void abort() const
std::vector< int > inputmap
Definition: PWBasis.h:108

◆ evaluate()

ValueType evaluate ( int  ib,
const PosType pos 
)
inline

Definition at line 74 of file PWOrbitalSet.h.

References PWOrbitalSet::BasisSetSize, PWOrbitalSet::C, Vector< T, Alloc >::data(), BLAS::dot(), PWBasis::evaluate(), PWOrbitalSet::myBasisSet, and PWBasis::Zv.

75  {
76  myBasisSet->evaluate(pos);
77  return BLAS::dot(BasisSetSize, (*C)[ib], myBasisSet->Zv.data());
78  }
void evaluate(const PosType &pos)
Definition: PWBasis.h:284
IndexType BasisSetSize
number of basis
Definition: PWOrbitalSet.h:101
ValueMatrix * C
pointer to matrix containing the coefficients
Definition: PWOrbitalSet.h:106
PWBasisPtr myBasisSet
My basis set.
Definition: PWOrbitalSet.h:99
Vector< ComplexType > Zv
Definition: PWBasis.h:89
static T dot(int n, const T *restrict a, const T *restrict b)
Definition: BLAS.hpp:304

◆ evaluate_notranspose()

void evaluate_notranspose ( const ParticleSet P,
int  first,
int  last,
ValueMatrix logdet,
GradMatrix dlogdet,
ValueMatrix d2logdet 
)
overridevirtual

evaluate the values, gradients and laplacians of this single-particle orbital for [first,last) particles

Parameters
[in]Pcurrent ParticleSet
[in]firststarting index of the particles
[in]lastending index of the particles
[out]logdetdeterminant matrix to be inverted
[out]dlogdetgradients
[out]d2logdetlaplacians

Implements SPOSet.

Definition at line 109 of file PWOrbitalSet.cpp.

References PWOrbitalSet::C, Matrix< T, Alloc >::data(), PWBasis::evaluateAll(), PWOrbitalSet::myBasisSet, SPOSet::OrbitalSetSize, qmcplusplus::MatrixOperators::product(), PWOrbitalSet::PW_GRADX, PWOrbitalSet::PW_GRADY, PWOrbitalSet::PW_GRADZ, PWOrbitalSet::PW_LAP, PWOrbitalSet::PW_MAXINDEX, PWOrbitalSet::PW_VALUE, PWOrbitalSet::Temp, and PWBasis::Z.

115 {
116  for (int iat = first, i = 0; iat < last; iat++, i++)
117  {
118  myBasisSet->evaluateAll(P, iat);
120  const ValueType* restrict tptr = Temp.data();
121  for (int j = 0; j < OrbitalSetSize; j++, tptr += PW_MAXINDEX)
122  {
123  logdet(i, j) = tptr[PW_VALUE];
124  d2logdet(i, j) = tptr[PW_LAP];
125  dlogdet(i, j) = GradType(tptr[PW_GRADX], tptr[PW_GRADY], tptr[PW_GRADZ]);
126  }
127  }
128 }
void evaluateAll(const ParticleSet &P, int iat)
Definition: PWBasis.h:291
QTBase::GradType GradType
Definition: Configuration.h:62
Matrix< ValueType > Temp
temporary array to perform gemm operation
Definition: PWOrbitalSet.h:112
ValueMatrix * C
pointer to matrix containing the coefficients
Definition: PWOrbitalSet.h:106
PWBasisPtr myBasisSet
My basis set.
Definition: PWOrbitalSet.h:99
QTBase::ValueType ValueType
Definition: Configuration.h:60
void product(const Matrix< T > &A, const Matrix< T > &B, Matrix< T > &C)
static function to perform C=AB for real matrices
Matrix< ComplexType > Z
Definition: PWBasis.h:87
IndexType OrbitalSetSize
number of Single-particle orbitals
Definition: SPOSet.h:566

◆ evaluateValue()

void evaluateValue ( const ParticleSet P,
int  iat,
ValueVector psi 
)
overridevirtual

evaluate the values of this single-particle orbital set

Parameters
Pcurrent ParticleSet
iatactive particle
psivalues of the SPO

Implements SPOSet.

Definition at line 86 of file PWOrbitalSet.cpp.

References ParticleSet::activeR(), PWOrbitalSet::C, PWBasis::evaluate(), PWOrbitalSet::myBasisSet, qmcplusplus::MatrixOperators::product(), and PWBasis::Zv.

87 {
88  //Evaluate every orbital for particle iat.
89  //Evaluate the basis-set at these coordinates:
90  //myBasisSet->evaluate(P,iat);
91  myBasisSet->evaluate(P.activeR(iat));
93 }
void evaluate(const PosType &pos)
Definition: PWBasis.h:284
ValueMatrix * C
pointer to matrix containing the coefficients
Definition: PWOrbitalSet.h:106
PWBasisPtr myBasisSet
My basis set.
Definition: PWOrbitalSet.h:99
Vector< ComplexType > Zv
Definition: PWBasis.h:89
void product(const Matrix< T > &A, const Matrix< T > &B, Matrix< T > &C)
static function to perform C=AB for real matrices

◆ evaluateVGL()

void evaluateVGL ( const ParticleSet P,
int  iat,
ValueVector psi,
GradVector dpsi,
ValueVector d2psi 
)
overridevirtual

evaluate the values, gradients and laplacians of this single-particle orbital set

Parameters
Pcurrent ParticleSet
iatactive particle
psivalues of the SPO
dpsigradients of the SPO
d2psilaplacians of the SPO

Implements SPOSet.

Definition at line 95 of file PWOrbitalSet.cpp.

References PWOrbitalSet::C, Matrix< T, Alloc >::data(), PWBasis::evaluateAll(), PWOrbitalSet::myBasisSet, SPOSet::OrbitalSetSize, qmcplusplus::MatrixOperators::product(), PWOrbitalSet::PW_GRADX, PWOrbitalSet::PW_GRADY, PWOrbitalSet::PW_GRADZ, PWOrbitalSet::PW_LAP, PWOrbitalSet::PW_MAXINDEX, PWOrbitalSet::PW_VALUE, PWOrbitalSet::Temp, and PWBasis::Z.

96 {
97  //Evaluate the orbitals and derivatives for particle iat only.
98  myBasisSet->evaluateAll(P, iat);
100  const ValueType* restrict tptr = Temp.data();
101  for (int j = 0; j < OrbitalSetSize; j++, tptr += PW_MAXINDEX)
102  {
103  psi[j] = tptr[PW_VALUE];
104  d2psi[j] = tptr[PW_LAP];
105  dpsi[j] = GradType(tptr[PW_GRADX], tptr[PW_GRADY], tptr[PW_GRADZ]);
106  }
107 }
void evaluateAll(const ParticleSet &P, int iat)
Definition: PWBasis.h:291
QTBase::GradType GradType
Definition: Configuration.h:62
Matrix< ValueType > Temp
temporary array to perform gemm operation
Definition: PWOrbitalSet.h:112
ValueMatrix * C
pointer to matrix containing the coefficients
Definition: PWOrbitalSet.h:106
PWBasisPtr myBasisSet
My basis set.
Definition: PWOrbitalSet.h:99
QTBase::ValueType ValueType
Definition: Configuration.h:60
void product(const Matrix< T > &A, const Matrix< T > &B, Matrix< T > &C)
static function to perform C=AB for real matrices
Matrix< ComplexType > Z
Definition: PWBasis.h:87
IndexType OrbitalSetSize
number of Single-particle orbitals
Definition: SPOSet.h:566

◆ getClassName()

std::string getClassName ( ) const
inlineoverridevirtual

return class name

Implements SPOSet.

Definition at line 50 of file PWOrbitalSet.h.

50 { return "PWOrbitalSet"; }

◆ makeClone()

std::unique_ptr< SPOSet > makeClone ( ) const
overridevirtual

make a clone of itself every derived class must implement this to have threading working correctly.

Reimplemented from SPOSet.

Definition at line 30 of file PWOrbitalSet.cpp.

References PWOrbitalSet::myBasisSet.

31 {
32  auto myclone = std::make_unique<PWOrbitalSet>(*this);
33  myclone->myBasisSet = new PWBasis(*myBasisSet);
34  myclone->IsCloned = true;
35  return myclone;
36 }
PWBasisPtr myBasisSet
My basis set.
Definition: PWOrbitalSet.h:99

◆ resize()

void resize ( PWBasisPtr  bset,
int  nbands,
bool  cleanup = false 
)

resize the orbital base

Parameters
bsetPWBasis
nbandsnumber of bands
cleaupif true, owns PWBasis. Will clean up.

Definition at line 40 of file PWOrbitalSet.cpp.

References qmcplusplus::app_log(), PWOrbitalSet::BasisSetSize, PWOrbitalSet::C, PWOrbitalSet::myBasisSet, PWBasis::NumPlaneWaves, SPOSet::OrbitalSetSize, PWOrbitalSet::OwnBasisSet, PWOrbitalSet::PW_MAXINDEX, Matrix< T, Alloc >::resize(), and PWOrbitalSet::Temp.

41 {
42  myBasisSet = bset;
43  OrbitalSetSize = nbands;
44  OwnBasisSet = cleanup;
48  app_log() << " PWOrbitalSet::resize OrbitalSetSize =" << OrbitalSetSize << " BasisSetSize = " << BasisSetSize
49  << std::endl;
50 }
IndexType BasisSetSize
number of basis
Definition: PWOrbitalSet.h:101
Matrix< ValueType > Temp
temporary array to perform gemm operation
Definition: PWOrbitalSet.h:112
std::ostream & app_log()
Definition: OutputManager.h:65
OrbitalSetTraits< ValueType >::ValueMatrix ValueMatrix
Definition: SPOSet.h:50
void resize(size_type n, size_type m)
Resize the container.
Definition: OhmmsMatrix.h:99
ValueMatrix * C
pointer to matrix containing the coefficients
Definition: PWOrbitalSet.h:106
PWBasisPtr myBasisSet
My basis set.
Definition: PWOrbitalSet.h:99
IndexType OrbitalSetSize
number of Single-particle orbitals
Definition: SPOSet.h:566
int NumPlaneWaves
total number of basis functions
Definition: PWBasis.h:111

◆ setOrbitalSetSize()

void setOrbitalSetSize ( int  norbs)
overridevirtual

set the OrbitalSetSize

Parameters
norbsnumber of single-particle orbitals Ye: I prefer to remove this interface in the future. SPOSet builders need to handle the size correctly. It doesn't make sense allowing to set the value at any place in the code.

Implements SPOSet.

Definition at line 38 of file PWOrbitalSet.cpp.

38 {}

Member Data Documentation

◆ BasisSetSize

IndexType BasisSetSize

number of basis

Definition at line 101 of file PWOrbitalSet.h.

Referenced by PWOrbitalSet::evaluate(), and PWOrbitalSet::resize().

◆ C

pointer to matrix containing the coefficients

makeClone makes a shallow copy and flag IsCloned

Definition at line 106 of file PWOrbitalSet.h.

Referenced by PWOrbitalSet::evaluate(), PWOrbitalSet::evaluate_notranspose(), PWOrbitalSet::evaluateValue(), PWOrbitalSet::evaluateVGL(), PWOrbitalSet::resize(), and PWOrbitalSet::~PWOrbitalSet().

◆ IsCloned

bool IsCloned

if true, do not clean up

Definition at line 108 of file PWOrbitalSet.h.

Referenced by PWOrbitalSet::~PWOrbitalSet().

◆ myBasisSet

◆ OwnBasisSet

bool OwnBasisSet

boolean

If true, this has to delete the BasisSet

Definition at line 95 of file PWOrbitalSet.h.

Referenced by PWOrbitalSet::resize(), and PWOrbitalSet::~PWOrbitalSet().

◆ Temp

temporary array to perform gemm operation

Definition at line 112 of file PWOrbitalSet.h.

Referenced by PWOrbitalSet::evaluate_notranspose(), PWOrbitalSet::evaluateVGL(), and PWOrbitalSet::resize().

◆ TwistAngle

PosType TwistAngle

TwistAngle of this PWOrbitalSet.

Definition at line 97 of file PWOrbitalSet.h.


The documentation for this class was generated from the following files: