![]() |
QMCPACK
|
Public Member Functions | |
StressPBC (ParticleSet &ions, ParticleSet &elns, TrialWaveFunction &Psi) | |
std::string | getClassName () const override |
return class name More... | |
Return_t | evaluate (ParticleSet &P) override |
Evaluate the local energy contribution of this component. More... | |
void | initBreakup (ParticleSet &P) |
SymTensor< RealType, OHMMS_DIM > | evaluateLR_AB (ParticleSet &P) |
SymTensor< RealType, OHMMS_DIM > | evaluateSR_AB (ParticleSet &P_target) |
SymTensor< RealType, OHMMS_DIM > | evaluateSR_AA (ParticleSet &P, int itabSelf) |
SymTensor< RealType, OHMMS_DIM > | evaluateLR_AA (ParticleSet &P) |
SymTensor< RealType, OHMMS_DIM > | evalConsts_AB () |
SymTensor< RealType, OHMMS_DIM > | evalConsts_AA (ParticleSet &P) |
SymTensor< RealType, OHMMS_DIM > | evaluateKineticSymTensor (ParticleSet &P) |
void | registerObservables (std::vector< ObservableHelper > &h5list, hdf_archive &file) const override |
add to observable descriptor for hdf5 The default implementation is to register a scalar for this->value_ More... | |
void | addObservables (PropertySetType &plist, BufferType &collectables) override |
named values to the property list Default implementaton uses addValue(plist_) More... | |
void | setObservables (PropertySetType &plist) override |
Set the values evaluated by this object to plist Default implementation is to assign Value which is updated by evaluate function using my_index_. More... | |
void | resetTargetParticleSet (ParticleSet &P) override |
Reset the data with the target ParticleSet. More... | |
void | setParticlePropertyList (PropertySetType &plist, int offset) override |
std::unique_ptr< OperatorBase > | makeClone (ParticleSet &qp, TrialWaveFunction &psi) final |
bool | put (xmlNodePtr cur) override |
Read the input parameter. More... | |
bool | get (std::ostream &os) const override |
write about the class More... | |
void | CalculateIonIonStress () |
![]() | |
OperatorBase () | |
Construct a new Operator Base object Default and unique empty constructor. More... | |
virtual | ~OperatorBase ()=default |
virtual bool | dependsOnWaveFunction () const |
return true if this operator depends on a wavefunction More... | |
std::bitset< 8 > & | getUpdateMode () noexcept |
get update_mode_ reference More... | |
Return_t | getValue () const noexcept |
get a copy of value_ More... | |
std::string | getName () const noexcept |
getter a copy of my_name_, rvalue small string optimization More... | |
void | setName (const std::string name) noexcept |
Set my_name member, uses small string optimization (pass by value) More... | |
TraceRequest & | getRequest () noexcept |
Get request_ member. More... | |
virtual void | registerCollectables (std::vector< ObservableHelper > &h5desc, hdf_archive &file) const |
virtual void | setHistories (Walker_t &ThisWalker) |
virtual Return_t | evaluateDeterministic (ParticleSet &P) |
Evaluate the local energy contribution of this component, deterministically based on current state. More... | |
virtual void | mw_evaluate (const RefVectorWithLeader< OperatorBase > &o_list, const RefVectorWithLeader< TrialWaveFunction > &wf_list, const RefVectorWithLeader< ParticleSet > &p_list) const |
Evaluate the contribution of this component of multiple walkers. More... | |
virtual void | mw_evaluatePerParticle (const RefVectorWithLeader< OperatorBase > &o_list, const RefVectorWithLeader< TrialWaveFunction > &wf_list, const RefVectorWithLeader< ParticleSet > &p_list, const std::vector< ListenerVector< RealType >> &listeners, const std::vector< ListenerVector< RealType >> &listeners_ions) const |
Evaluate the contribution of this component of multiple walkers per particle and report to registerd listeners from objects in Estimators. More... | |
virtual void | mw_evaluateWithParameterDerivatives (const RefVectorWithLeader< OperatorBase > &o_list, const RefVectorWithLeader< ParticleSet > &p_list, const opt_variables_type &optvars, const RecordArray< ValueType > &dlogpsi, RecordArray< ValueType > &dhpsioverpsi) const |
TODO: add docs. More... | |
virtual Return_t | rejectedMove (ParticleSet &P) |
TODO: add docs. More... | |
virtual Return_t | evaluateWithToperator (ParticleSet &P) |
Evaluate the local energy contribution of this component with Toperators updated if requested. More... | |
virtual void | mw_evaluateWithToperator (const RefVectorWithLeader< OperatorBase > &o_list, const RefVectorWithLeader< TrialWaveFunction > &wf_list, const RefVectorWithLeader< ParticleSet > &p_list) const |
Evaluate the contribution of this component of multiple walkers. More... | |
virtual void | mw_evaluatePerParticleWithToperator (const RefVectorWithLeader< OperatorBase > &o_list, const RefVectorWithLeader< TrialWaveFunction > &wf_list, const RefVectorWithLeader< ParticleSet > &p_list, const std::vector< ListenerVector< RealType >> &listeners, const std::vector< ListenerVector< RealType >> &listeners_ions) const |
Evaluate the contribution of this component of multiple walkers per particle and report to registerd listeners from objects in Estimators. More... | |
virtual Return_t | evaluateValueAndDerivatives (ParticleSet &P, const opt_variables_type &optvars, const Vector< ValueType > &dlogpsi, Vector< ValueType > &dhpsioverpsi) |
Evaluate value and derivatives wrt the optimizables. More... | |
virtual Return_t | evaluateWithIonDerivs (ParticleSet &P, ParticleSet &ions, TrialWaveFunction &psi, ParticleSet::ParticlePos &hf_term, ParticleSet::ParticlePos &pulay_term) |
Evaluate contribution to local energy and derivatives w.r.t ionic coordinates from OperatorBase. More... | |
virtual Return_t | evaluateWithIonDerivsDeterministic (ParticleSet &P, ParticleSet &ions, TrialWaveFunction &psi, ParticleSet::ParticlePos &hf_term, ParticleSet::ParticlePos &pulay_term) |
Evaluate contribution to local energy and derivatives w.r.t ionic coordinates from OperatorBase. More... | |
virtual void | evaluateOneBodyOpMatrix (ParticleSet &P, const TWFFastDerivWrapper &psi, std::vector< ValueMatrix > &B) |
Evaluate "B" matrix for observable. More... | |
virtual void | evaluateOneBodyOpMatrixForceDeriv (ParticleSet &P, ParticleSet &source, const TWFFastDerivWrapper &psi, const int iat, std::vector< std::vector< ValueMatrix >> &Bforce) |
Evaluate "dB/dR" matrices for observable. More... | |
virtual void | updateSource (ParticleSet &s) |
Update data associated with a particleset. More... | |
virtual Return_t | getEnsembleAverage () |
Return an average value by collective operation. 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< OperatorBase > &o_list) const |
Acquire a shared resource from a collection. More... | |
virtual void | releaseResource (ResourceCollection &collection, const RefVectorWithLeader< OperatorBase > &o_list) const |
Return a shared resource to a collection. More... | |
virtual void | setRandomGenerator (RandomBase< FullPrecRealType > *rng) |
Set the Random Generator object TODO: add docs. More... | |
virtual void | add2Hamiltonian (ParticleSet &qp, TrialWaveFunction &psi, QMCHamiltonian &targetH) |
TODO: add docs. More... | |
virtual void | getRequiredTraces (TraceManager &tm) |
TODO: add docs. More... | |
virtual void | informOfPerParticleListener () |
bool | isClassical () const noexcept |
bool | isQuantum () const noexcept |
bool | isClassicalClassical () const noexcept |
bool | isQuantumClassical () const noexcept |
bool | isQuantumQuantum () const noexcept |
bool | getMode (const int i) const noexcept |
Return the mode i. More... | |
bool | isNonLocal () const noexcept |
TODO: add docs. More... | |
bool | hasListener () const noexcept |
void | contributeTraceQuantities () |
Make trace quantities available. More... | |
void | checkoutTraceQuantities (TraceManager &tm) |
Checkout trace arrays Derived classes must guard individual checkouts using request info. More... | |
void | collectScalarTraces () |
Collect scalar trace data. More... | |
void | deleteTraceQuantities () |
delete trace arrays More... | |
![]() | |
Real | g (Real r) |
void | initVarReduction (Real rcut, int m, int numFuncs) |
ForceBase (ParticleSet &ions, ParticleSet &elns) | |
virtual | ~ForceBase () |
void | registerObservablesF (std::vector< ObservableHelper > &h5list, hdf_archive &file) const |
void | addObservablesF (QMCTraits::PropertySetType &plist) |
void | addObservablesStress (QMCTraits::PropertySetType &plist) |
void | setObservablesF (QMCTraits::PropertySetType &plist) |
void | setObservablesStress (QMCTraits::PropertySetType &plist) |
void | setParticleSetF (QMCTraits::PropertySetType &plist, int offset) |
void | setParticleSetStress (QMCTraits::PropertySetType &plist, int offset) |
bool | getAddIonIon () const noexcept |
void | setAddIonIon (bool val) noexcept |
const ParticleSet::ParticlePos & | getForces () const noexcept |
void | setForces (const ParticleSet::ParticlePos &forces) |
void | setForces (Real val) |
const ParticleSet::ParticlePos & | getForcesIonIon () const noexcept |
void | setForcesIonIon (const ParticleSet::ParticlePos &forces_ion_ion) |
const SymTensor< Real, OHMMS_DIM > & | getStressIonIon () const noexcept |
const SymTensor< Real, OHMMS_DIM > & | getStressEE () const noexcept |
const SymTensor< Real, OHMMS_DIM > & | getStressEI () const noexcept |
const SymTensor< Real, OHMMS_DIM > & | getStressKin () const noexcept |
const SymTensor< Real, OHMMS_DIM > & | getStress () const noexcept |
Public Attributes | |
SymTensor< RealType, OHMMS_DIM > | stress_ee_const |
SymTensor< RealType, OHMMS_DIM > | stress_eI_const |
TrialWaveFunction & | Psi |
ParticleSet & | PtclTarg |
source particle set More... | |
ParticleSet & | PtclA |
std::unique_ptr< LRHandlerType > | AA |
long-range Handler More... | |
const int | ei_table_index |
locator of the distance table More... | |
const int | ee_table_index |
e-e table ID More... | |
const int | ii_table_index |
int | NumSpeciesA |
number of species of A particle set More... | |
int | NumSpeciesB |
number of species of B particle set More... | |
int | NptclA |
number of particles of A (classical, e.g. ions) More... | |
int | NptclB |
number of particles of B (quantum, e.g. electrons) More... | |
std::vector< int > | NofSpeciesA |
number of particles per species of A More... | |
std::vector< int > | NofSpeciesB |
number of particles per species of B More... | |
std::vector< RealType > | Zat |
Zat[iat] charge for the iat-th particle of A. More... | |
std::vector< RealType > | Qat |
Qat[iat] charge for the iat-th particle of B. More... | |
std::vector< RealType > | Zspec |
Zspec[spec] charge for the spec-th species of A. More... | |
std::vector< RealType > | Qspec |
Qspec[spec] charge for the spec-th species of B. More... | |
bool | firstTimeStress |
Additional Inherited Members | |
![]() | |
virtual void | contributeScalarQuantities () |
virtual void | checkoutScalarQuantities (TraceManager &tm) |
virtual void | collectScalarQuantities () |
virtual void | deleteScalarQuantities () |
virtual void | contributeParticleQuantities () |
virtual void | checkoutParticleQuantities (TraceManager &tm) |
virtual void | deleteParticleQuantities () |
virtual void | setComputeForces (bool compute) |
void | setEnergyDomain (EnergyDomains edomain) |
Set the Energy Domain. More... | |
void | setQuantumDomain (QuantumDomains qdomain) |
set quantum domain More... | |
void | oneBodyQuantumDomain (const ParticleSet &P) |
set quantum domain for one-body operator More... | |
void | twoBodyQuantumDomain (const ParticleSet &P) |
set quantum domain for two-body operator More... | |
void | twoBodyQuantumDomain (const ParticleSet &P1, const ParticleSet &P2) |
set quantum domain for two-body operator More... | |
void | addValue (PropertySetType &plist) |
named values to the property list More... | |
![]() | |
std::bitset< 8 > | update_mode_ |
set the current update mode More... | |
Return_t | value_ |
current value More... | |
std::string | name_ |
name of this object More... | |
TraceRequest | request_ |
whether traces are being collected More... | |
int | my_index_ |
starting index of this object More... | |
Return_t | new_value_ |
a new value for a proposed move More... | |
Walker_t * | t_walker_ |
reference to the current walker More... | |
bool | streaming_particles_ |
bool | have_required_traces_ |
![]() | |
int | first_force_index_ |
int | n_nuc_ |
int | n_el_ |
int | tries_ |
bool | first_time_ |
bool | add_ion_ion_ |
Determines if ion-ion force will be added to electron-ion force in derived force estimators. If false, forces_ion_ion_=0.0. More... | |
ParticleSet & | ions_ |
ParticleSet::ParticlePos | forces_ |
ParticleSet::ParticlePos | forces_ion_ion_ |
SymTensor< Real, OHMMS_DIM > | stress_ion_ion_ |
SymTensor< Real, OHMMS_DIM > | stress_ee_ |
SymTensor< Real, OHMMS_DIM > | stress_ei_ |
SymTensor< Real, OHMMS_DIM > | stress_kin_ |
SymTensor< Real, OHMMS_DIM > | stress_ |
std::string | prefix_ |
std::string | pair_name_ |
Real | rcut_ |
int | m_ |
std::vector< Real > | ck_ |
Definition at line 24 of file StressPBC.h.
Definition at line 26 of file StressPBC.h.
StressPBC | ( | ParticleSet & | ions, |
ParticleSet & | elns, | ||
TrialWaveFunction & | Psi | ||
) |
Definition at line 28 of file StressPBC.cpp.
References qmcplusplus::app_log(), StressPBC::CalculateIonIonStress(), StressPBC::firstTimeStress, ParticleSet::getLattice(), StressPBC::initBreakup(), OperatorBase::name_, ForceBase::prefix_, StressPBC::PtclTarg, StressPBC::stress_ee_const, StressPBC::stress_eI_const, and ForceBase::stress_ion_ion_.
|
inlineoverridevirtual |
named values to the property list Default implementaton uses addValue(plist_)
plist | RecordNameProperty |
collectables | Observables that are accumulated by evaluate |
Reimplemented from OperatorBase.
Definition at line 89 of file StressPBC.h.
References ForceBase::addObservablesStress().
|
inline |
Definition at line 105 of file StressPBC.h.
References StressPBC::evalConsts_AA(), StressPBC::evalConsts_AB(), StressPBC::evaluateLR_AA(), StressPBC::evaluateSR_AA(), StressPBC::ii_table_index, StressPBC::PtclA, StressPBC::PtclTarg, StressPBC::stress_ee_const, StressPBC::stress_eI_const, and ForceBase::stress_ion_ion_.
Referenced by StressPBC::StressPBC().
SymTensor< StressPBC::RealType, OHMMS_DIM > evalConsts_AA | ( | ParticleSet & | P | ) |
Definition at line 215 of file StressPBC.cpp.
References StressPBC::AA, qmcplusplus::app_log(), SpeciesSet::getAttribute(), ParticleSet::getSpeciesSet(), ParticleSet::getTotalNum(), ParticleSet::groupsize(), SpeciesSet::TotalNum, and ParticleSet::Z.
Referenced by StressPBC::CalculateIonIonStress().
SymTensor< StressPBC::RealType, OHMMS_DIM > evalConsts_AB | ( | ) |
Definition at line 187 of file StressPBC.cpp.
References StressPBC::AA, ParticleSet::getTotalNum(), StressPBC::NofSpeciesA, StressPBC::NofSpeciesB, StressPBC::NumSpeciesA, StressPBC::NumSpeciesB, StressPBC::PtclA, StressPBC::PtclTarg, StressPBC::Qat, StressPBC::Qspec, qmcplusplus::Units::time::s, StressPBC::Zat, and StressPBC::Zspec.
Referenced by StressPBC::CalculateIonIonStress().
|
overridevirtual |
Evaluate the local energy contribution of this component.
P | input configuration containing N particles |
Implements OperatorBase.
Definition at line 262 of file StressPBC.cpp.
References ForceBase::add_ion_ion_, StressPBC::ee_table_index, StressPBC::evaluateKineticSymTensor(), StressPBC::evaluateLR_AA(), StressPBC::evaluateLR_AB(), StressPBC::evaluateSR_AA(), StressPBC::evaluateSR_AB(), ParticleSet::getLattice(), StressPBC::PtclTarg, ForceBase::stress_, ForceBase::stress_ee_, StressPBC::stress_ee_const, ForceBase::stress_ei_, StressPBC::stress_eI_const, ForceBase::stress_ion_ion_, and ForceBase::stress_kin_.
Referenced by qmcplusplus::TEST_CASE().
SymTensor< StressPBC::RealType, OHMMS_DIM > evaluateKineticSymTensor | ( | ParticleSet & | P | ) |
Definition at line 288 of file StressPBC.cpp.
References TrialWaveFunction::evaluateHessian(), ParticleSet::G, ParticleSet::getTotalNum(), ParticleSet::Mass, OHMMS_DIM, qmcplusplus::outerProduct(), and StressPBC::Psi.
Referenced by StressPBC::evaluate().
SymTensor< StressPBC::RealType, OHMMS_DIM > evaluateLR_AA | ( | ParticleSet & | P | ) |
Definition at line 151 of file StressPBC.cpp.
References StressPBC::AA, SpeciesSet::getAttribute(), ParticleSet::getSimulationCell(), ParticleSet::getSK(), ParticleSet::getSpeciesSet(), ParticleSet::groupsize(), and SpeciesSet::TotalNum.
Referenced by StressPBC::CalculateIonIonStress(), and StressPBC::evaluate().
SymTensor< StressPBC::RealType, OHMMS_DIM > evaluateLR_AB | ( | ParticleSet & | P | ) |
Definition at line 93 of file StressPBC.cpp.
References StressPBC::AA, ParticleSet::getSimulationCell(), ParticleSet::getSK(), StressPBC::NumSpeciesA, StressPBC::NumSpeciesB, StressPBC::PtclA, StressPBC::Qspec, and StressPBC::Zspec.
Referenced by StressPBC::evaluate().
SymTensor< StressPBC::RealType, OHMMS_DIM > evaluateSR_AA | ( | ParticleSet & | P, |
int | itabSelf | ||
) |
Definition at line 131 of file StressPBC.cpp.
References StressPBC::AA, ParticleSet::getDistTableAA(), StressPBC::NptclB, and ParticleSet::Z.
Referenced by StressPBC::CalculateIonIonStress(), and StressPBC::evaluate().
SymTensor< StressPBC::RealType, OHMMS_DIM > evaluateSR_AB | ( | ParticleSet & | P_target | ) |
Definition at line 113 of file StressPBC.cpp.
References StressPBC::AA, qmcplusplus::Units::charge::e, StressPBC::ei_table_index, ParticleSet::getDistTableAB(), StressPBC::NptclA, StressPBC::NptclB, StressPBC::Qat, and StressPBC::Zat.
Referenced by StressPBC::evaluate().
|
inlineoverridevirtual |
write about the class
Implements OperatorBase.
Definition at line 99 of file StressPBC.h.
References ForceBase::pair_name_.
|
inlineoverridevirtual |
void initBreakup | ( | ParticleSet & | P | ) |
Definition at line 56 of file StressPBC.cpp.
References StressPBC::AA, SpeciesSet::addAttribute(), qmcplusplus::for(), LRCoulombSingleton::getDerivHandler(), ParticleSet::getSpeciesSet(), ParticleSet::getTotalNum(), ParticleSet::GroupID, ParticleSet::groupsize(), StressPBC::NofSpeciesA, StressPBC::NofSpeciesB, StressPBC::NptclA, StressPBC::NptclB, StressPBC::NumSpeciesA, StressPBC::NumSpeciesB, StressPBC::PtclA, StressPBC::Qat, StressPBC::Qspec, StressPBC::Zat, and StressPBC::Zspec.
Referenced by StressPBC::StressPBC().
|
finalvirtual |
Implements OperatorBase.
Definition at line 322 of file StressPBC.cpp.
References ForceBase::add_ion_ion_, StressPBC::firstTimeStress, StressPBC::PtclA, StressPBC::stress_ee_const, StressPBC::stress_eI_const, and ForceBase::stress_ion_ion_.
|
overridevirtual |
Read the input parameter.
cur | xml node for a OperatorBase object |
Implements OperatorBase.
Definition at line 310 of file StressPBC.cpp.
References OhmmsAttributeSet::add(), ForceBase::add_ion_ion_, qmcplusplus::app_log(), ForceBase::prefix_, and OhmmsAttributeSet::put().
|
inlineoverridevirtual |
add to observable descriptor for hdf5 The default implementation is to register a scalar for this->value_
h5desc | contains a set of hdf5 descriptors for a scalar observable |
gid | hdf5 group to which the observables belong |
Reimplemented from OperatorBase.
Definition at line 84 of file StressPBC.h.
References ForceBase::registerObservablesF().
|
inlineoverridevirtual |
Reset the data with the target ParticleSet.
P | new target ParticleSet |
Implements OperatorBase.
Definition at line 93 of file StressPBC.h.
|
inlineoverridevirtual |
Set the values evaluated by this object to plist Default implementation is to assign Value which is updated by evaluate function using my_index_.
plist | RecordNameProperty |
Reimplemented from OperatorBase.
Definition at line 91 of file StressPBC.h.
References ForceBase::setObservablesStress().
|
inlineoverridevirtual |
Reimplemented from OperatorBase.
Definition at line 95 of file StressPBC.h.
References ForceBase::setParticleSetStress().
std::unique_ptr<LRHandlerType> AA |
long-range Handler
Definition at line 38 of file StressPBC.h.
Referenced by StressPBC::evalConsts_AA(), StressPBC::evalConsts_AB(), StressPBC::evaluateLR_AA(), StressPBC::evaluateLR_AB(), StressPBC::evaluateSR_AA(), StressPBC::evaluateSR_AB(), and StressPBC::initBreakup().
const int ee_table_index |
const int ei_table_index |
locator of the distance table
Definition at line 40 of file StressPBC.h.
Referenced by StressPBC::evaluateSR_AB().
bool firstTimeStress |
Definition at line 66 of file StressPBC.h.
Referenced by StressPBC::makeClone(), and StressPBC::StressPBC().
const int ii_table_index |
Definition at line 43 of file StressPBC.h.
Referenced by StressPBC::CalculateIonIonStress().
std::vector<int> NofSpeciesA |
number of particles per species of A
Definition at line 54 of file StressPBC.h.
Referenced by StressPBC::evalConsts_AB(), and StressPBC::initBreakup().
std::vector<int> NofSpeciesB |
number of particles per species of B
Definition at line 56 of file StressPBC.h.
Referenced by StressPBC::evalConsts_AB(), and StressPBC::initBreakup().
int NptclA |
number of particles of A (classical, e.g. ions)
Definition at line 49 of file StressPBC.h.
Referenced by StressPBC::evaluateSR_AB(), and StressPBC::initBreakup().
int NptclB |
number of particles of B (quantum, e.g. electrons)
Definition at line 51 of file StressPBC.h.
Referenced by StressPBC::evaluateSR_AA(), StressPBC::evaluateSR_AB(), and StressPBC::initBreakup().
int NumSpeciesA |
number of species of A particle set
Definition at line 45 of file StressPBC.h.
Referenced by StressPBC::evalConsts_AB(), StressPBC::evaluateLR_AB(), and StressPBC::initBreakup().
int NumSpeciesB |
number of species of B particle set
Definition at line 47 of file StressPBC.h.
Referenced by StressPBC::evalConsts_AB(), StressPBC::evaluateLR_AB(), and StressPBC::initBreakup().
TrialWaveFunction& Psi |
Definition at line 32 of file StressPBC.h.
Referenced by StressPBC::evaluateKineticSymTensor().
ParticleSet& PtclA |
Definition at line 36 of file StressPBC.h.
Referenced by StressPBC::CalculateIonIonStress(), StressPBC::evalConsts_AB(), StressPBC::evaluateLR_AB(), StressPBC::initBreakup(), and StressPBC::makeClone().
ParticleSet& PtclTarg |
source particle set
Definition at line 35 of file StressPBC.h.
Referenced by StressPBC::CalculateIonIonStress(), StressPBC::evalConsts_AB(), StressPBC::evaluate(), and StressPBC::StressPBC().
std::vector<RealType> Qat |
Qat[iat] charge for the iat-th particle of B.
Definition at line 60 of file StressPBC.h.
Referenced by StressPBC::evalConsts_AB(), StressPBC::evaluateSR_AB(), and StressPBC::initBreakup().
std::vector<RealType> Qspec |
Qspec[spec] charge for the spec-th species of B.
Definition at line 64 of file StressPBC.h.
Referenced by StressPBC::evalConsts_AB(), StressPBC::evaluateLR_AB(), and StressPBC::initBreakup().
Definition at line 28 of file StressPBC.h.
Referenced by StressPBC::CalculateIonIonStress(), StressPBC::evaluate(), StressPBC::makeClone(), and StressPBC::StressPBC().
Definition at line 29 of file StressPBC.h.
Referenced by StressPBC::CalculateIonIonStress(), StressPBC::evaluate(), StressPBC::makeClone(), and StressPBC::StressPBC().
std::vector<RealType> Zat |
Zat[iat] charge for the iat-th particle of A.
Definition at line 58 of file StressPBC.h.
Referenced by StressPBC::evalConsts_AB(), StressPBC::evaluateSR_AB(), and StressPBC::initBreakup().
std::vector<RealType> Zspec |
Zspec[spec] charge for the spec-th species of A.
Definition at line 62 of file StressPBC.h.
Referenced by StressPBC::evalConsts_AB(), StressPBC::evaluateLR_AB(), and StressPBC::initBreakup().