![]() |
QMCPACK
|
Public Member Functions | |
AGPDeterminant (BasisSetType *bs=nullptr) | |
constructor More... | |
~AGPDeterminant () override | |
default destructor More... | |
std::string | getClassName () const override |
return class name More... | |
void | resize (int nup, int ndown) |
reset the size: with the number of particles and number of orbtials More... | |
void | registerData (ParticleSet &P, WFBufferType &buf) override |
For particle-by-particle move. More... | |
LogValue | updateBuffer (ParticleSet &P, WFBufferType &buf, bool fromscratch=false) override |
For particle-by-particle move. More... | |
void | copyFromBuffer (ParticleSet &P, WFBufferType &buf) override |
For particle-by-particle move. More... | |
PsiValue | ratio (ParticleSet &P, int iat) override |
return the ratio only for the iat-th partcle move More... | |
void | ratioUp (ParticleSet &P, int iat) |
void | ratioDown (ParticleSet &P, int iat) |
void | acceptMove (ParticleSet &P, int iat, bool safe_to_delay=false) override |
move was accepted, update the real container More... | |
void | restore (int iat) override |
move was rejected. More... | |
void | resizeByWalkers (int nwalkers) |
LogValue | evaluateLog (const ParticleSet &P, ParticleSet::ParticleGradient &G, ParticleSet::ParticleLaplacian &L) override |
Calculate the log value of the Dirac determinant for particles. More... | |
std::unique_ptr< WaveFunctionComponent > | makeClone (ParticleSet &tqp) const override |
make clone More... | |
void | evaluateDerivatives (ParticleSet &P, const opt_variables_type &optvars, Vector< ValueType > &dlogpsi, Vector< ValueType > &dhpsioverpsi) override |
Compute the derivatives of both the log of the wavefunction and kinetic energy with respect to optimizable parameters. More... | |
void | evaluateLogAndStore (const ParticleSet &P) |
![]() | |
const LogValue & | get_log_value () const |
WaveFunctionComponent (const std::string &obj_name="") | |
default constructor More... | |
virtual | ~WaveFunctionComponent () |
default destructor More... | |
virtual void | checkSanity () const |
Validate the internal consistency of the object. More... | |
const std::string & | getName () const |
return object name More... | |
PsiValue | getValue () const |
assembles the full value More... | |
virtual bool | isFermionic () const |
true, if this component is fermionic More... | |
virtual bool | isMultiDet () const |
true, if this component is multi-determinant More... | |
virtual void | checkOutVariables (const opt_variables_type &active) |
check out variational optimizable variables More... | |
virtual void | registerTWFFastDerivWrapper (const ParticleSet &P, TWFFastDerivWrapper &twf) const |
Register the component with the TWFFastDerivWrapper wrapper. More... | |
virtual void | mw_evaluateLog (const RefVectorWithLeader< WaveFunctionComponent > &wfc_list, const RefVectorWithLeader< ParticleSet > &p_list, const RefVector< ParticleSet::ParticleGradient > &G_list, const RefVector< ParticleSet::ParticleLaplacian > &L_list) const |
evaluate from scratch the same type WaveFunctionComponent of multiple walkers More... | |
virtual void | recompute (const ParticleSet &P) |
recompute the value of the WaveFunctionComponents which require critical accuracy. More... | |
virtual void | mw_recompute (const RefVectorWithLeader< WaveFunctionComponent > &wfc_list, const RefVectorWithLeader< ParticleSet > &p_list, const std::vector< bool > &recompute) const |
virtual void | evaluateHessian (ParticleSet &P, HessVector &grad_grad_psi_all) |
virtual void | prepareGroup (ParticleSet &P, int ig) |
Prepare internal data for updating WFC correspond to a particle group It should be called before moving particles of a given group. More... | |
virtual void | mw_prepareGroup (const RefVectorWithLeader< WaveFunctionComponent > &wfc_list, const RefVectorWithLeader< ParticleSet > &p_list, int ig) const |
virtual GradType | evalGrad (ParticleSet &P, int iat) |
return the current gradient for the iat-th particle More... | |
virtual GradType | evalGradWithSpin (ParticleSet &P, int iat, ComplexType &spingrad) |
return the current spin gradient for the iat-th particle Default implementation assumes that WaveFunctionComponent does not explicitly depend on Spin. More... | |
template<CoordsType CT> | |
void | mw_evalGrad (const RefVectorWithLeader< WaveFunctionComponent > &wfc_list, const RefVectorWithLeader< ParticleSet > &p_list, const int iat, TWFGrads< CT > &grads_now) const |
compute the current gradients for the iat-th particle of multiple walkers More... | |
virtual void | mw_evalGrad (const RefVectorWithLeader< WaveFunctionComponent > &wfc_list, const RefVectorWithLeader< ParticleSet > &p_list, int iat, std::vector< GradType > &grad_now) const |
compute the current gradients for the iat-th particle of multiple walkers More... | |
virtual GradType | evalGradSource (ParticleSet &P, ParticleSet &source, int iat) |
return the logarithmic gradient for the iat-th particle of the source particleset More... | |
virtual GradType | evalGradSource (ParticleSet &P, ParticleSet &source, int iat, TinyVector< ParticleSet::ParticleGradient, OHMMS_DIM > &grad_grad, TinyVector< ParticleSet::ParticleLaplacian, OHMMS_DIM > &lapl_grad) |
Adds the gradient w.r.t. More... | |
virtual PsiValue | ratioGrad (ParticleSet &P, int iat, GradType &grad_iat) |
evaluate the ratio of the new to old WaveFunctionComponent value and the new gradient More... | |
virtual PsiValue | ratioGradWithSpin (ParticleSet &P, int iat, GradType &grad_iat, ComplexType &spingrad_iat) |
evaluate the ratio of the new to old WaveFunctionComponent value and the new spin gradient Default implementation assumes that WaveFunctionComponent does not explicitly depend on Spin. More... | |
template<CoordsType CT> | |
void | mw_ratioGrad (const RefVectorWithLeader< WaveFunctionComponent > &wfc_list, const RefVectorWithLeader< ParticleSet > &p_list, int iat, std::vector< PsiValue > &ratios, TWFGrads< CT > &grad_new) const |
virtual void | mw_ratioGrad (const RefVectorWithLeader< WaveFunctionComponent > &wfc_list, const RefVectorWithLeader< ParticleSet > &p_list, int iat, std::vector< PsiValue > &ratios, std::vector< GradType > &grad_new) const |
compute the ratio of the new to old WaveFunctionComponent value and the new gradient of multiple walkers More... | |
virtual void | mw_accept_rejectMove (const RefVectorWithLeader< WaveFunctionComponent > &wfc_list, const RefVectorWithLeader< ParticleSet > &p_list, int iat, const std::vector< bool > &isAccepted, bool safe_to_delay=false) const |
moves of the iat-th particle on some walkers in a batch is accepted. More... | |
virtual void | completeUpdates () |
complete all the delayed or asynchronous operations before leaving the p-by-p move region. More... | |
virtual void | mw_completeUpdates (const RefVectorWithLeader< WaveFunctionComponent > &wfc_list) const |
complete all the delayed or asynchronous operations for all the walkers in a batch before leaving the p-by-p move region. More... | |
virtual void | mw_calcRatio (const RefVectorWithLeader< WaveFunctionComponent > &wfc_list, const RefVectorWithLeader< ParticleSet > &p_list, int iat, std::vector< PsiValue > &ratios) const |
compute the ratio of the new to old WaveFunctionComponent value of multiple walkers More... | |
virtual LogValue | evaluateGL (const ParticleSet &P, ParticleSet::ParticleGradient &G, ParticleSet::ParticleLaplacian &L, bool fromscratch) |
compute gradients and laplacian of the TWF with respect to each particle. More... | |
virtual void | mw_evaluateGL (const RefVectorWithLeader< WaveFunctionComponent > &wfc_list, const RefVectorWithLeader< ParticleSet > &p_list, const RefVector< ParticleSet::ParticleGradient > &G_list, const RefVector< ParticleSet::ParticleLaplacian > &L_list, bool fromscratch) const |
evaluate gradients and laplacian of the same type WaveFunctionComponent of multiple walkers More... | |
virtual void | createResource (ResourceCollection &collection) const |
initialize a shared resource and hand it to a collection More... | |
virtual void | acquireResource (ResourceCollection &collection, const RefVectorWithLeader< WaveFunctionComponent > &wfc_list) const |
acquire a shared resource from a collection More... | |
virtual void | releaseResource (ResourceCollection &collection, const RefVectorWithLeader< WaveFunctionComponent > &wfc_list) const |
return a shared resource to a collection More... | |
virtual RealType | KECorrection () |
Return the Chiesa kinetic energy correction. More... | |
virtual bool | isOptimizable () const |
if true, this contains optimizable components More... | |
virtual void | extractOptimizableObjectRefs (UniqueOptObjRefs &opt_obj_refs) |
extract underlying OptimizableObject references More... | |
virtual void | evaluateDerivativesWF (ParticleSet &P, const opt_variables_type &optvars, Vector< ValueType > &dlogpsi) |
Compute the derivatives of the log of the wavefunction with respect to optimizable parameters. More... | |
virtual void | evaluateGradDerivatives (const ParticleSet::ParticleGradient &G_in, std::vector< ValueType > &dgradlogpsi) |
Calculates the derivatives of ![]() | |
virtual void | finalizeOptimization () |
virtual void | evaluateRatiosAlltoOne (ParticleSet &P, std::vector< ValueType > &ratios) |
evaluate the ratios of one virtual move with respect to all the particles More... | |
virtual void | evaluateRatios (const VirtualParticleSet &VP, std::vector< ValueType > &ratios) |
evaluate ratios to evaluate the non-local PP More... | |
virtual void | evaluateSpinorRatios (const VirtualParticleSet &VP, const std::pair< ValueVector, ValueVector > &spinor_multiplier, std::vector< ValueType > &ratios) |
Used by SOECPComponent for faster SOC evaluation. More... | |
virtual void | mw_evaluateRatios (const RefVectorWithLeader< WaveFunctionComponent > &wfc_list, const RefVectorWithLeader< const VirtualParticleSet > &vp_list, std::vector< std::vector< ValueType >> &ratios) const |
evaluate ratios to evaluate the non-local PP multiple walkers More... | |
virtual void | evaluateDerivRatios (const VirtualParticleSet &VP, const opt_variables_type &optvars, std::vector< ValueType > &ratios, Matrix< ValueType > &dratios) |
evaluate ratios to evaluate the non-local PP More... | |
virtual void | mw_evalGradWithSpin (const RefVectorWithLeader< WaveFunctionComponent > &wfc_list, const RefVectorWithLeader< ParticleSet > &p_list, int iat, std::vector< GradType > &grad_now, std::vector< ComplexType > &spingrad_now) const |
compute the current gradients and spin gradients for the iat-th particle of multiple walkers More... | |
virtual void | mw_ratioGradWithSpin (const RefVectorWithLeader< WaveFunctionComponent > &wfc_list, const RefVectorWithLeader< ParticleSet > &p_list, int iat, std::vector< PsiValue > &ratios, std::vector< GradType > &grad_new, std::vector< ComplexType > &spingrad_new) const |
compute the ratio of the new to old WaveFunctionComponent value and the new gradient/spingradient of multiple walkers More... | |
Additional Inherited Members | |
![]() | |
const std::string | my_name_ |
Name of the object It is required to be different for objects of the same derived type like multiple J1. More... | |
LogValue | log_value_ |
Current ![]() | |
Definition at line 27 of file AGPDeterminant.h.
using BasisSetType = BasisSetBase<RealType> |
define BasisSetType with RealType
Definition at line 31 of file AGPDeterminant.h.
using GradMatrix = BasisSetType::GradMatrix |
Definition at line 36 of file AGPDeterminant.h.
using GradVector = BasisSetType::GradVector |
Definition at line 35 of file AGPDeterminant.h.
using IndexVector = BasisSetType::IndexVector |
Definition at line 32 of file AGPDeterminant.h.
using ValueMatrix = BasisSetType::ValueMatrix |
Definition at line 34 of file AGPDeterminant.h.
using ValueVector = BasisSetType::ValueVector |
Definition at line 33 of file AGPDeterminant.h.
AGPDeterminant | ( | BasisSetType * | bs = nullptr | ) |
constructor
spos | the single-particle orbital set |
first | index of the first particle |
Definition at line 24 of file AGPDeterminant.cpp.
|
override |
|
overridevirtual |
move was accepted, update the real container
Implements WaveFunctionComponent.
Definition at line 337 of file AGPDeterminant.cpp.
References APP_ABORT, qmcplusplus::convertValueToLog(), copy(), AGPDeterminant::curRatio, BasisSetBase< T >::d2Phi, AGPDeterminant::d2Y, BasisSetBase< T >::dPhi, AGPDeterminant::dY, AGPDeterminant::GeminalBasis, qmcplusplus::InverseUpdateByColumn(), qmcplusplus::InverseUpdateByRow(), WaveFunctionComponent::log_value_, AGPDeterminant::myG, AGPDeterminant::myG_temp, AGPDeterminant::myL, AGPDeterminant::myL_temp, AGPDeterminant::Nup, WaveFunctionComponent::ORB_PBYP_RATIO, AGPDeterminant::psiD, AGPDeterminant::psiM, AGPDeterminant::psiM_temp, AGPDeterminant::psiU, WaveFunctionComponent::UpdateMode, AGPDeterminant::workV1, and AGPDeterminant::workV2.
|
overridevirtual |
For particle-by-particle move.
Copy data or attach memory from a walker buffer to the objects of this class. The log value, P.G and P.L contribution from the objects of this class are also added.
P | particle set |
buf | Anonymous storage |
Implements WaveFunctionComponent.
Definition at line 200 of file AGPDeterminant.cpp.
References Matrix< T, Alloc >::begin(), AGPDeterminant::d2psiD, AGPDeterminant::d2psiU, AGPDeterminant::d2Y, Matrix< T, Alloc >::end(), Vector< T, Alloc >::first_address(), AGPDeterminant::FirstAddressOfdVD, AGPDeterminant::FirstAddressOfdVU, AGPDeterminant::FirstAddressOfdY, AGPDeterminant::FirstAddressOfG, PooledMemory< T_scalar, Alloc >::get(), Vector< T, Alloc >::last_address(), AGPDeterminant::LastAddressOfdVD, AGPDeterminant::LastAddressOfdVU, AGPDeterminant::LastAddressOfdY, AGPDeterminant::LastAddressOfG, WaveFunctionComponent::log_value_, AGPDeterminant::myL, AGPDeterminant::phiT, AGPDeterminant::psiM, and AGPDeterminant::psiM_temp.
|
inlineoverridevirtual |
Compute the derivatives of both the log of the wavefunction and kinetic energy with respect to optimizable parameters.
P | particle set |
optvars | optimizable parameters |
dlogpsi | array of derivatives of the log of the wavefunction. Add the contribution from this component. |
dhpsioverpsi | array of Hamiltonian derivatives. Add the kinetic energy derivatives contribution from this component. ![]() ![]() ![]() ![]() |
Implements WaveFunctionComponent.
Definition at line 96 of file AGPDeterminant.h.
|
overridevirtual |
Calculate the log value of the Dirac determinant for particles.
P | input configuration containing N particles |
G | a vector containing N gradients |
L | a vector containing N laplacians |
Add the gradient and laplacian contribution of the determinant to G(radient) and L(aplacian) for local energy calculations.
Implements WaveFunctionComponent.
Definition at line 83 of file AGPDeterminant.cpp.
References AGPDeterminant::evaluateLogAndStore(), WaveFunctionComponent::log_value_, AGPDeterminant::myG, and AGPDeterminant::myL.
void evaluateLogAndStore | ( | const ParticleSet & | P | ) |
Definition at line 93 of file AGPDeterminant.cpp.
References AGPDeterminant::BasisSize, AGPDeterminant::d2psiD, AGPDeterminant::d2psiU, BasisSetBase< T >::d2Y, AGPDeterminant::d2Y, Matrix< T, Alloc >::data(), qmcplusplus::simd::dot(), qmcplusplus::dot(), AGPDeterminant::dpsiD, AGPDeterminant::dpsiU, BasisSetBase< T >::dY, AGPDeterminant::dY, BasisSetBase< T >::evaluateForWalkerMove(), AGPDeterminant::GeminalBasis, qmcplusplus::InvertWithLog(), AGPDeterminant::Lambda, AGPDeterminant::LambdaUP, WaveFunctionComponent::log_value_, AGPDeterminant::myG, AGPDeterminant::myL, AGPDeterminant::Ndown, AGPDeterminant::NumPtcls, AGPDeterminant::Nup, AGPDeterminant::phiT, AGPDeterminant::Pivot, qmcplusplus::MatrixOperators::product(), AGPDeterminant::psiM, AGPDeterminant::WorkSpace, and BasisSetBase< T >::Y.
Referenced by AGPDeterminant::evaluateLog(), and AGPDeterminant::updateBuffer().
|
inlineoverridevirtual |
|
overridevirtual |
make clone
tqp | target Quantum ParticleSet |
deepcopy | if true, make a decopy |
If not true, return a proxy class
Reimplemented from WaveFunctionComponent.
Definition at line 397 of file AGPDeterminant.cpp.
References AGPDeterminant::GeminalBasis, AGPDeterminant::Lambda, AGPDeterminant::LambdaUP, BasisSetBase< T >::makeClone(), AGPDeterminant::Ndown, AGPDeterminant::Nup, and BasisSetBase< T >::resize().
|
overridevirtual |
return the ratio only for the iat-th partcle move
P | current configuration |
iat | the particle thas is being moved |
Implements WaveFunctionComponent.
Definition at line 227 of file AGPDeterminant.cpp.
References AGPDeterminant::BasisSize, AGPDeterminant::curRatio, qmcplusplus::DetRatioByColumn(), qmcplusplus::DetRatioByRow(), qmcplusplus::simd::dot(), BasisSetBase< T >::evaluateForPtclMove(), AGPDeterminant::GeminalBasis, AGPDeterminant::LambdaUP, AGPDeterminant::Ndown, AGPDeterminant::Nup, WaveFunctionComponent::ORB_PBYP_RATIO, BasisSetBase< T >::Phi, AGPDeterminant::phiT, AGPDeterminant::psiD, AGPDeterminant::psiM, AGPDeterminant::psiU, and WaveFunctionComponent::UpdateMode.
void ratioDown | ( | ParticleSet & | P, |
int | iat | ||
) |
Definition at line 302 of file AGPDeterminant.cpp.
References AGPDeterminant::BasisSize, copy(), AGPDeterminant::curRatio, BasisSetBase< T >::d2Phi, AGPDeterminant::d2psiD, AGPDeterminant::d2psiDv, AGPDeterminant::d2psiU, AGPDeterminant::d2psiUv, AGPDeterminant::d2Y, qmcplusplus::DetRatioByColumn(), qmcplusplus::simd::dot(), BasisSetBase< T >::dPhi, AGPDeterminant::dpsiD, AGPDeterminant::dpsiDv, AGPDeterminant::dpsiU, AGPDeterminant::dpsiUv, AGPDeterminant::dY, AGPDeterminant::GeminalBasis, qmcplusplus::InverseUpdateByColumn(), AGPDeterminant::Nup, BasisSetBase< T >::Phi, AGPDeterminant::phiT, AGPDeterminant::psiD, AGPDeterminant::psiM_temp, AGPDeterminant::workV1, and AGPDeterminant::workV2.
void ratioUp | ( | ParticleSet & | P, |
int | iat | ||
) |
Definition at line 259 of file AGPDeterminant.cpp.
References AGPDeterminant::BasisSize, copy(), AGPDeterminant::curRatio, BasisSetBase< T >::d2Phi, AGPDeterminant::d2psiD, AGPDeterminant::d2psiDv, AGPDeterminant::d2psiU, AGPDeterminant::d2psiUv, AGPDeterminant::d2Y, qmcplusplus::DetRatioByRow(), qmcplusplus::simd::dot(), BasisSetBase< T >::dPhi, AGPDeterminant::dpsiD, AGPDeterminant::dpsiDv, AGPDeterminant::dpsiU, AGPDeterminant::dpsiUv, AGPDeterminant::dY, AGPDeterminant::GeminalBasis, qmcplusplus::InverseUpdateByRow(), AGPDeterminant::LambdaUP, AGPDeterminant::Ndown, AGPDeterminant::NumPtcls, AGPDeterminant::Nup, BasisSetBase< T >::Phi, AGPDeterminant::phiT, AGPDeterminant::psiM_temp, AGPDeterminant::psiU, AGPDeterminant::workV1, and AGPDeterminant::workV2.
|
overridevirtual |
For particle-by-particle move.
Requests space in the buffer based on the data type sizes of the objects in this class.
P | particle set |
buf | Anonymous storage |
Implements WaveFunctionComponent.
Definition at line 157 of file AGPDeterminant.cpp.
References PooledMemory< T_scalar, Alloc >::add(), Matrix< T, Alloc >::begin(), AGPDeterminant::d2psiD, AGPDeterminant::d2psiU, AGPDeterminant::d2Y, Matrix< T, Alloc >::end(), Vector< T, Alloc >::first_address(), AGPDeterminant::FirstAddressOfdVD, AGPDeterminant::FirstAddressOfdVU, AGPDeterminant::FirstAddressOfdY, AGPDeterminant::FirstAddressOfG, Vector< T, Alloc >::last_address(), AGPDeterminant::LastAddressOfdVD, AGPDeterminant::LastAddressOfdVU, AGPDeterminant::LastAddressOfdY, AGPDeterminant::LastAddressOfG, WaveFunctionComponent::log_value_, AGPDeterminant::myL, AGPDeterminant::phiT, and AGPDeterminant::psiM.
void resize | ( | int | nup, |
int | ndown | ||
) |
reset the size: with the number of particles and number of orbtials
Definition at line 27 of file AGPDeterminant.cpp.
References qmcplusplus::app_log(), AGPDeterminant::BasisSize, AGPDeterminant::d2psiD, AGPDeterminant::d2psiDv, AGPDeterminant::d2psiU, AGPDeterminant::d2psiUv, AGPDeterminant::d2Y, QMCTraits::DIM, AGPDeterminant::dpsiD, AGPDeterminant::dpsiDv, AGPDeterminant::dpsiU, AGPDeterminant::dpsiUv, AGPDeterminant::dY, AGPDeterminant::FirstAddressOfdVD, AGPDeterminant::FirstAddressOfdVU, AGPDeterminant::FirstAddressOfdY, AGPDeterminant::FirstAddressOfG, AGPDeterminant::GeminalBasis, BasisSetBase< T >::getBasisSetSize(), AGPDeterminant::Lambda, AGPDeterminant::LambdaUP, AGPDeterminant::LastAddressOfdVD, AGPDeterminant::LastAddressOfdVU, AGPDeterminant::LastAddressOfdY, AGPDeterminant::LastAddressOfG, AGPDeterminant::myG, AGPDeterminant::myG_temp, AGPDeterminant::myL, AGPDeterminant::myL_temp, AGPDeterminant::Ndown, AGPDeterminant::NumPtcls, AGPDeterminant::Nup, AGPDeterminant::phiT, AGPDeterminant::phiTv, AGPDeterminant::Pivot, AGPDeterminant::psiD, AGPDeterminant::psiM, AGPDeterminant::psiM_temp, AGPDeterminant::psiU, Matrix< T, Alloc >::resize(), Vector< T, Alloc >::resize(), and AGPDeterminant::WorkSpace.
void resizeByWalkers | ( | int | nwalkers | ) |
|
overridevirtual |
move was rejected.
copy the real container to the temporary to move on
Implements WaveFunctionComponent.
Definition at line 366 of file AGPDeterminant.cpp.
References copy(), AGPDeterminant::curRatio, AGPDeterminant::d2psiD, AGPDeterminant::d2psiDv, AGPDeterminant::d2psiU, AGPDeterminant::d2psiUv, AGPDeterminant::dpsiD, AGPDeterminant::dpsiDv, AGPDeterminant::dpsiU, AGPDeterminant::dpsiUv, AGPDeterminant::Ndown, AGPDeterminant::Nup, WaveFunctionComponent::ORB_PBYP_RATIO, AGPDeterminant::phiT, AGPDeterminant::phiTv, AGPDeterminant::psiM, AGPDeterminant::psiM_temp, and WaveFunctionComponent::UpdateMode.
|
overridevirtual |
For particle-by-particle move.
Put the objects of this class in the walker buffer or forward the memory cursor.
P | particle set |
buf | Anonymous storage |
fromscratch | request recomputing the precision critical pieces of wavefunction from scratch |
Implements WaveFunctionComponent.
Definition at line 175 of file AGPDeterminant.cpp.
References Matrix< T, Alloc >::begin(), AGPDeterminant::d2psiD, AGPDeterminant::d2psiU, AGPDeterminant::d2Y, Matrix< T, Alloc >::end(), AGPDeterminant::evaluateLogAndStore(), Vector< T, Alloc >::first_address(), AGPDeterminant::FirstAddressOfdVD, AGPDeterminant::FirstAddressOfdVU, AGPDeterminant::FirstAddressOfdY, AGPDeterminant::FirstAddressOfG, ParticleSet::G, ParticleSet::L, Vector< T, Alloc >::last_address(), AGPDeterminant::LastAddressOfdVD, AGPDeterminant::LastAddressOfdVU, AGPDeterminant::LastAddressOfdY, AGPDeterminant::LastAddressOfG, WaveFunctionComponent::log_value_, AGPDeterminant::myG, AGPDeterminant::myL, AGPDeterminant::phiT, AGPDeterminant::psiM, and PooledMemory< T_scalar, Alloc >::put().
int BasisSize |
size of the basis set
Definition at line 109 of file AGPDeterminant.h.
Referenced by AGPDeterminant::evaluateLogAndStore(), AGPDeterminant::ratio(), AGPDeterminant::ratioDown(), AGPDeterminant::ratioUp(), and AGPDeterminant::resize().
RealType cumRatio |
cummulate ratio for particle-by-particle update
Definition at line 162 of file AGPDeterminant.h.
PsiValue curRatio |
current ratio
Definition at line 160 of file AGPDeterminant.h.
Referenced by AGPDeterminant::acceptMove(), AGPDeterminant::ratio(), AGPDeterminant::ratioDown(), AGPDeterminant::ratioUp(), and AGPDeterminant::restore().
ValueMatrix d2psiD |
Definition at line 143 of file AGPDeterminant.h.
Referenced by AGPDeterminant::copyFromBuffer(), AGPDeterminant::evaluateLogAndStore(), AGPDeterminant::ratioDown(), AGPDeterminant::ratioUp(), AGPDeterminant::registerData(), AGPDeterminant::resize(), AGPDeterminant::restore(), and AGPDeterminant::updateBuffer().
ValueVector d2psiDv |
Definition at line 154 of file AGPDeterminant.h.
Referenced by AGPDeterminant::ratioDown(), AGPDeterminant::ratioUp(), AGPDeterminant::resize(), and AGPDeterminant::restore().
ValueMatrix d2psiU |
temporary determinant-related matrix for laplacians
Definition at line 143 of file AGPDeterminant.h.
Referenced by AGPDeterminant::copyFromBuffer(), AGPDeterminant::evaluateLogAndStore(), AGPDeterminant::ratioDown(), AGPDeterminant::ratioUp(), AGPDeterminant::registerData(), AGPDeterminant::resize(), AGPDeterminant::restore(), and AGPDeterminant::updateBuffer().
ValueVector d2psiUv |
Definition at line 154 of file AGPDeterminant.h.
Referenced by AGPDeterminant::ratioDown(), AGPDeterminant::ratioUp(), AGPDeterminant::resize(), and AGPDeterminant::restore().
ValueMatrix d2Y |
store laplacians
Definition at line 139 of file AGPDeterminant.h.
Referenced by AGPDeterminant::acceptMove(), AGPDeterminant::copyFromBuffer(), AGPDeterminant::evaluateLogAndStore(), AGPDeterminant::ratioDown(), AGPDeterminant::ratioUp(), AGPDeterminant::registerData(), AGPDeterminant::resize(), and AGPDeterminant::updateBuffer().
GradMatrix dpsiD |
Definition at line 141 of file AGPDeterminant.h.
Referenced by AGPDeterminant::evaluateLogAndStore(), AGPDeterminant::ratioDown(), AGPDeterminant::ratioUp(), AGPDeterminant::resize(), and AGPDeterminant::restore().
GradVector dpsiDv |
Definition at line 153 of file AGPDeterminant.h.
Referenced by AGPDeterminant::ratioDown(), AGPDeterminant::ratioUp(), AGPDeterminant::resize(), and AGPDeterminant::restore().
GradMatrix dpsiU |
temporary determinant-related matrix for gradients
Definition at line 141 of file AGPDeterminant.h.
Referenced by AGPDeterminant::evaluateLogAndStore(), AGPDeterminant::ratioDown(), AGPDeterminant::ratioUp(), AGPDeterminant::resize(), and AGPDeterminant::restore().
GradVector dpsiUv |
Definition at line 153 of file AGPDeterminant.h.
Referenced by AGPDeterminant::ratioDown(), AGPDeterminant::ratioUp(), AGPDeterminant::resize(), and AGPDeterminant::restore().
GradMatrix dY |
store gradients
Definition at line 137 of file AGPDeterminant.h.
Referenced by AGPDeterminant::acceptMove(), AGPDeterminant::evaluateLogAndStore(), AGPDeterminant::ratioDown(), AGPDeterminant::ratioUp(), and AGPDeterminant::resize().
BasisSetType::ValueType* FirstAddressOfdVD |
address of dpsiD[0][0]
Definition at line 168 of file AGPDeterminant.h.
Referenced by AGPDeterminant::copyFromBuffer(), AGPDeterminant::registerData(), AGPDeterminant::resize(), and AGPDeterminant::updateBuffer().
BasisSetType::ValueType* FirstAddressOfdVU |
address of dpsiU[0][0]
Definition at line 164 of file AGPDeterminant.h.
Referenced by AGPDeterminant::copyFromBuffer(), AGPDeterminant::registerData(), AGPDeterminant::resize(), and AGPDeterminant::updateBuffer().
BasisSetType::ValueType* FirstAddressOfdY |
address of dY[0][0]
Definition at line 176 of file AGPDeterminant.h.
Referenced by AGPDeterminant::copyFromBuffer(), AGPDeterminant::registerData(), AGPDeterminant::resize(), and AGPDeterminant::updateBuffer().
ParticleSet::SingleParticleValue* FirstAddressOfG |
address of myG[0][0]
Definition at line 172 of file AGPDeterminant.h.
Referenced by AGPDeterminant::copyFromBuffer(), AGPDeterminant::registerData(), AGPDeterminant::resize(), and AGPDeterminant::updateBuffer().
BasisSetType* GeminalBasis |
Definition at line 38 of file AGPDeterminant.h.
Referenced by AGPDeterminant::acceptMove(), AGPDeterminant::evaluateLogAndStore(), AGPDeterminant::makeClone(), AGPDeterminant::ratio(), AGPDeterminant::ratioDown(), AGPDeterminant::ratioUp(), and AGPDeterminant::resize().
ValueMatrix Lambda |
coefficient of the up/down block
Definition at line 118 of file AGPDeterminant.h.
Referenced by AGPDeterminant::evaluateLogAndStore(), AGPDeterminant::makeClone(), and AGPDeterminant::resize().
ValueMatrix LambdaUP |
coefficient of the major block
Definition at line 121 of file AGPDeterminant.h.
Referenced by AGPDeterminant::evaluateLogAndStore(), AGPDeterminant::makeClone(), AGPDeterminant::ratio(), AGPDeterminant::ratioUp(), and AGPDeterminant::resize().
BasisSetType::ValueType* LastAddressOfdVD |
address of FirstAddressOfdVD+OHMMS_DIM*Ndown*Nup
Definition at line 170 of file AGPDeterminant.h.
Referenced by AGPDeterminant::copyFromBuffer(), AGPDeterminant::registerData(), AGPDeterminant::resize(), and AGPDeterminant::updateBuffer().
BasisSetType::ValueType* LastAddressOfdVU |
address of FirstAddressOfdVU+OHMMS_DIM*Nup*Nup
Definition at line 166 of file AGPDeterminant.h.
Referenced by AGPDeterminant::copyFromBuffer(), AGPDeterminant::registerData(), AGPDeterminant::resize(), and AGPDeterminant::updateBuffer().
BasisSetType::ValueType* LastAddressOfdY |
address of FirstAddressOfdY+NumPtcls*BasisSize
Definition at line 178 of file AGPDeterminant.h.
Referenced by AGPDeterminant::copyFromBuffer(), AGPDeterminant::registerData(), AGPDeterminant::resize(), and AGPDeterminant::updateBuffer().
ParticleSet::SingleParticleValue* LastAddressOfG |
address of FirstAddressOfG+OHMMS_DIM*NumPtcls
Definition at line 174 of file AGPDeterminant.h.
Referenced by AGPDeterminant::copyFromBuffer(), AGPDeterminant::registerData(), AGPDeterminant::resize(), and AGPDeterminant::updateBuffer().
Definition at line 180 of file AGPDeterminant.h.
Referenced by AGPDeterminant::acceptMove(), AGPDeterminant::evaluateLog(), AGPDeterminant::evaluateLogAndStore(), AGPDeterminant::resize(), and AGPDeterminant::updateBuffer().
ParticleSet::ParticleGradient myG_temp |
Definition at line 180 of file AGPDeterminant.h.
Referenced by AGPDeterminant::acceptMove(), and AGPDeterminant::resize().
Definition at line 181 of file AGPDeterminant.h.
Referenced by AGPDeterminant::acceptMove(), AGPDeterminant::copyFromBuffer(), AGPDeterminant::evaluateLog(), AGPDeterminant::evaluateLogAndStore(), AGPDeterminant::registerData(), AGPDeterminant::resize(), and AGPDeterminant::updateBuffer().
ParticleSet::ParticleLaplacian myL_temp |
Definition at line 181 of file AGPDeterminant.h.
Referenced by AGPDeterminant::acceptMove(), and AGPDeterminant::resize().
int Ndown |
number of minor spins
Definition at line 107 of file AGPDeterminant.h.
Referenced by AGPDeterminant::evaluateLogAndStore(), AGPDeterminant::makeClone(), AGPDeterminant::ratio(), AGPDeterminant::ratioUp(), AGPDeterminant::resize(), and AGPDeterminant::restore().
int NumPtcls |
Total number of particles.
Definition at line 103 of file AGPDeterminant.h.
Referenced by AGPDeterminant::evaluateLogAndStore(), AGPDeterminant::ratioUp(), and AGPDeterminant::resize().
int Nup |
number of major spins
Definition at line 105 of file AGPDeterminant.h.
Referenced by AGPDeterminant::acceptMove(), AGPDeterminant::evaluateLogAndStore(), AGPDeterminant::makeClone(), AGPDeterminant::ratio(), AGPDeterminant::ratioDown(), AGPDeterminant::ratioUp(), AGPDeterminant::resize(), and AGPDeterminant::restore().
ValueMatrix phiT |
Transient data for gradient and laplacian evaluation.
j runs over the particle index index
Definition at line 132 of file AGPDeterminant.h.
Referenced by AGPDeterminant::copyFromBuffer(), AGPDeterminant::evaluateLogAndStore(), AGPDeterminant::ratio(), AGPDeterminant::ratioDown(), AGPDeterminant::ratioUp(), AGPDeterminant::registerData(), AGPDeterminant::resize(), AGPDeterminant::restore(), and AGPDeterminant::updateBuffer().
ValueVector phiTv |
value of single-particle orbital for particle-by-particle update
temporary vector for a particle-by-particle move
phiTv = Lambda Y(iat)
Definition at line 150 of file AGPDeterminant.h.
Referenced by AGPDeterminant::resize(), and AGPDeterminant::restore().
IndexVector Pivot |
Definition at line 157 of file AGPDeterminant.h.
Referenced by AGPDeterminant::evaluateLogAndStore(), and AGPDeterminant::resize().
Definition at line 152 of file AGPDeterminant.h.
Referenced by AGPDeterminant::acceptMove(), AGPDeterminant::ratio(), AGPDeterminant::ratioDown(), and AGPDeterminant::resize().
psiM(j,i)
Definition at line 124 of file AGPDeterminant.h.
Referenced by AGPDeterminant::acceptMove(), AGPDeterminant::copyFromBuffer(), AGPDeterminant::evaluateLogAndStore(), AGPDeterminant::ratio(), AGPDeterminant::registerData(), AGPDeterminant::resize(), AGPDeterminant::restore(), and AGPDeterminant::updateBuffer().
Definition at line 124 of file AGPDeterminant.h.
Referenced by AGPDeterminant::acceptMove(), AGPDeterminant::copyFromBuffer(), AGPDeterminant::ratioDown(), AGPDeterminant::ratioUp(), AGPDeterminant::resize(), and AGPDeterminant::restore().
ValueMatrix psiMinv |
temporary container for testing
Definition at line 135 of file AGPDeterminant.h.
ValueVector psiU |
Definition at line 151 of file AGPDeterminant.h.
Referenced by AGPDeterminant::acceptMove(), AGPDeterminant::ratio(), AGPDeterminant::ratioUp(), and AGPDeterminant::resize().
int WorkingIndex |
index of the particle (or row)
Definition at line 112 of file AGPDeterminant.h.
ValueVector WorkSpace |
Definition at line 156 of file AGPDeterminant.h.
Referenced by AGPDeterminant::evaluateLogAndStore(), and AGPDeterminant::resize().
Definition at line 155 of file AGPDeterminant.h.
Referenced by AGPDeterminant::acceptMove(), AGPDeterminant::ratioDown(), and AGPDeterminant::ratioUp().
Definition at line 155 of file AGPDeterminant.h.
Referenced by AGPDeterminant::acceptMove(), AGPDeterminant::ratioDown(), and AGPDeterminant::ratioUp().