![]() |
QMCPACK
|
Inheritance diagram for CoulombPotential< T >:
Collaboration diagram for CoulombPotential< T >:Public Member Functions | |
| CoulombPotential (ParticleSet &s, bool active, bool computeForces, bool copy=false) | |
| constructor for AA More... | |
| CoulombPotential (ParticleSet &s, ParticleSet &t, bool active, bool copy=false) | |
| constructor for AB More... | |
| std::string | getClassName () const override |
| return class name More... | |
| void | contributeParticleQuantities () override |
| void | checkoutParticleQuantities (TraceManager &tm) override |
| void | deleteParticleQuantities () override |
| void | addObservables (PropertySetType &plist, BufferType &collectables) override |
| named values to the property list Default implementaton uses addValue(plist_) More... | |
| T | evaluateAA (const DistanceTableAA &d, const ParticleScalar *restrict Z) |
| evaluate AA-type interactions More... | |
| void | evaluateAAForces (const DistanceTableAA &d, const ParticleScalar *restrict Z) |
| evaluate AA-type forces More... | |
| T | evaluateAB (const DistanceTableAB &d, const ParticleScalar *restrict Za, const ParticleScalar *restrict Zb) |
| JNKIM: Need to check the precision. More... | |
| T | evaluate_spAA (const DistanceTableAA &d, const ParticleScalar *restrict Z) |
| evaluate AA-type interactions More... | |
| T | evaluate_spAB (const DistanceTableAB &d, const ParticleScalar *restrict Za, const ParticleScalar *restrict Zb) |
| void | resetTargetParticleSet (ParticleSet &P) override |
| Reset the data with the target ParticleSet. More... | |
| ~CoulombPotential () override | |
| void | updateSource (ParticleSet &s) override |
| Update data associated with a particleset. More... | |
| Return_t | evaluate (ParticleSet &P) override |
| Evaluate the local energy contribution of this component. More... | |
| Return_t | evaluateWithIonDerivs (ParticleSet &P, ParticleSet &ions, TrialWaveFunction &psi, ParticleSet::ParticlePos &hf_terms, ParticleSet::ParticlePos &pulay_terms) override |
| Evaluate contribution to local energy and derivatives w.r.t ionic coordinates from OperatorBase. More... | |
| bool | put (xmlNodePtr cur) override |
| Read the input parameter. More... | |
| bool | get (std::ostream &os) const override |
| write about the class 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 | setParticlePropertyList (PropertySetType &plist, int offset) override |
| std::unique_ptr< OperatorBase > | makeClone (ParticleSet &qp, TrialWaveFunction &psi) override |
Public Member Functions inherited from OperatorBase | |
| 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 | registerObservables (std::vector< ObservableHelper > &h5desc, hdf_archive &file) const |
| add to observable descriptor for hdf5 The default implementation is to register a scalar for this->value_ 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 | 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 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... | |
Public Member Functions inherited from ForceBase | |
| 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 | |
| ParticleSet & | Pa |
| source particle set More... | |
| ParticleSet & | Pb |
| target particle set More... | |
| const int | myTableIndex |
| distance table index More... | |
| const bool | is_AA |
| true if the table is AA More... | |
| bool | is_active |
| true, if CoulombAA for quantum particleset More... | |
| int | nCenters |
| number of centers More... | |
| Array< TraceReal, 1 > * | Va_sample |
| single particle trace samples More... | |
| Array< TraceReal, 1 > * | Vb_sample |
| bool | ComputeForces |
| Flag for whether to compute forces or not. More... | |
Additional Inherited Members | |
Public Types inherited from OperatorBase | |
| enum | EnergyDomains { KINETIC = 0, POTENTIAL, NO_ENERGY_DOMAIN } |
| enum to denote energy domain of operators More... | |
| enum | QuantumDomains { NO_QUANTUM_DOMAIN = 0, CLASSICAL, QUANTUM, CLASSICAL_CLASSICAL, QUANTUM_CLASSICAL, QUANTUM_QUANTUM } |
| enum | { PRIMARY = 0, OPTIMIZABLE = 1, RATIOUPDATE = 2, PHYSICAL = 3, COLLECTABLE = 4, NONLOCAL = 5 } |
| enum for update_mode More... | |
| using | Return_t = FullPrecRealType |
| type of return value of evaluate More... | |
| using | ValueMatrix = SPOSet::ValueMatrix |
| For fast derivative evaluation. More... | |
| using | GradMatrix = SPOSet::GradMatrix |
| using | BufferType = ParticleSet::Buffer_t |
| typedef for the serialized buffer More... | |
| using | Walker_t = ParticleSet::Walker_t |
| typedef for the walker More... | |
| using | ParticleScalar = ParticleSet::Scalar_t |
| typedef for the ParticleScalar More... | |
| using | SPOMap = SPOSet::SPOMap |
| typedef for SPOMap More... | |
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 Types inherited from ForceBase | |
| using | Real = QMCTraits::RealType |
| cheat, need to use virtual inheriance to clean up More... | |
Protected Member Functions inherited from OperatorBase | |
| virtual void | contributeScalarQuantities () |
| virtual void | checkoutScalarQuantities (TraceManager &tm) |
| virtual void | collectScalarQuantities () |
| virtual void | deleteScalarQuantities () |
| 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... | |
Protected Attributes inherited from OperatorBase | |
| 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_ |
Protected Attributes inherited from ForceBase | |
| 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_ |
| T | type of the elementary data |
Hamiltonian operator for the Coulomb interaction for both AA and AB type for open systems.
Definition at line 37 of file CoulombPotential.h.
|
inline |
constructor for AA
| s | source particleset |
| active | if true, new Value is computed whenver evaluate is used. |
| computeForces | if true, computes forces between inactive species |
Definition at line 65 of file CoulombPotential.h.
References CoulombPotential< T >::ComputeForces, copy(), CoulombPotential< T >::evaluateAA(), CoulombPotential< T >::evaluateAAForces(), CoulombPotential< T >::is_active, CoulombPotential< T >::myTableIndex, CoulombPotential< T >::nCenters, OperatorBase::POTENTIAL, ForceBase::prefix_, qmcplusplus::Units::time::s, OperatorBase::setEnergyDomain(), OperatorBase::twoBodyQuantumDomain(), and OperatorBase::value_.
|
inline |
constructor for AB
| s | source particleset |
| t | target particleset |
| active | if true, new Value is computed whenver evaluate is used. |
| ComputeForces | is not implemented for AB |
Definition at line 95 of file CoulombPotential.h.
References CoulombPotential< T >::nCenters, OperatorBase::POTENTIAL, qmcplusplus::Units::time::s, OperatorBase::setEnergyDomain(), and OperatorBase::twoBodyQuantumDomain().
|
inlineoverride |
Definition at line 321 of file CoulombPotential.h.
|
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 140 of file CoulombPotential.h.
References ForceBase::addObservablesF(), OperatorBase::addValue(), and CoulombPotential< T >::ComputeForces.
|
inlineoverridevirtual |
Reimplemented from OperatorBase.
Definition at line 114 of file CoulombPotential.h.
References TraceManager::checkout_real(), CoulombPotential< T >::evaluate_spAA(), ParticleSet::getDistTableAA(), CoulombPotential< T >::is_AA, CoulombPotential< T >::is_active, CoulombPotential< T >::myTableIndex, OperatorBase::name_, CoulombPotential< T >::Pa, CoulombPotential< T >::Pb, OperatorBase::request_, TraceRequest::streaming_array(), OperatorBase::streaming_particles_, CoulombPotential< T >::Va_sample, CoulombPotential< T >::Vb_sample, and ParticleSet::Z.
|
inlineoverridevirtual |
Reimplemented from OperatorBase.
Definition at line 112 of file CoulombPotential.h.
References TraceRequest::contribute_array(), OperatorBase::name_, and OperatorBase::request_.
|
inlineoverridevirtual |
Reimplemented from OperatorBase.
Definition at line 129 of file CoulombPotential.h.
References CoulombPotential< T >::is_AA, OperatorBase::streaming_particles_, CoulombPotential< T >::Va_sample, and CoulombPotential< T >::Vb_sample.
|
inlineoverridevirtual |
Evaluate the local energy contribution of this component.
| P | input configuration containing N particles |
Implements OperatorBase.
Definition at line 331 of file CoulombPotential.h.
References CoulombPotential< T >::evaluateAA(), CoulombPotential< T >::evaluateAB(), ParticleSet::getDistTableAA(), ParticleSet::getDistTableAB(), CoulombPotential< T >::is_AA, CoulombPotential< T >::is_active, CoulombPotential< T >::myTableIndex, CoulombPotential< T >::Pa, OperatorBase::value_, and ParticleSet::Z.
Referenced by CoulombPotential< T >::evaluateWithIonDerivs().
|
inline |
evaluate AA-type interactions
Definition at line 212 of file CoulombPotential.h.
References qmcplusplus::abs(), APP_ABORT, qmcplusplus::app_log(), CoulombPotential< T >::evaluateAA(), DistanceTableAA::getDistRow(), CoulombPotential< T >::nCenters, OperatorBase::streaming_particles_, Array< T, D, ALLOC >::sum(), TraceManager::trace_tol, and CoulombPotential< T >::Va_sample.
Referenced by CoulombPotential< T >::checkoutParticleQuantities(), and CoulombPotential< T >::evaluateAA().
|
inline |
Definition at line 257 of file CoulombPotential.h.
References qmcplusplus::abs(), APP_ABORT, qmcplusplus::app_log(), CoulombPotential< T >::evaluateAB(), DistanceTableAB::getDistRow(), CoulombPotential< T >::nCenters, OperatorBase::streaming_particles_, Array< T, D, ALLOC >::sum(), DistanceTable::targets(), TraceManager::trace_tol, CoulombPotential< T >::Va_sample, and CoulombPotential< T >::Vb_sample.
Referenced by CoulombPotential< T >::evaluateAB().
|
inline |
evaluate AA-type interactions
Definition at line 148 of file CoulombPotential.h.
References CoulombPotential< T >::evaluate_spAA(), DistanceTableAA::getDistRow(), CoulombPotential< T >::nCenters, and OperatorBase::streaming_particles_.
Referenced by CoulombPotential< T >::CoulombPotential(), CoulombPotential< T >::evaluate(), CoulombPotential< T >::evaluate_spAA(), and CoulombPotential< T >::updateSource().
|
inline |
evaluate AA-type forces
Definition at line 168 of file CoulombPotential.h.
References ForceBase::forces_, DistanceTableAA::getDisplRow(), DistanceTableAA::getDistRow(), and CoulombPotential< T >::nCenters.
Referenced by CoulombPotential< T >::CoulombPotential().
|
inline |
JNKIM: Need to check the precision.
Definition at line 186 of file CoulombPotential.h.
References BLAS::czero, qmcplusplus::Units::charge::e, CoulombPotential< T >::evaluate_spAB(), DistanceTableAB::getDistRow(), CoulombPotential< T >::nCenters, OperatorBase::streaming_particles_, and DistanceTable::targets().
Referenced by CoulombPotential< T >::evaluate(), and CoulombPotential< T >::evaluate_spAB().
|
inlineoverridevirtual |
Evaluate contribution to local energy and derivatives w.r.t ionic coordinates from OperatorBase.
| P | target particle set (electrons) |
| ions | source particle set (ions) |
| psi | Trial wave function |
| hf_terms | Adds OperatorBase's contribution to Re [(dH)Psi]/Psi |
| pulay_terms | Adds OperatorBase's contribution to Re [(H-E_L)dPsi]/Psi |
Reimplemented from OperatorBase.
Definition at line 343 of file CoulombPotential.h.
References CoulombPotential< T >::evaluate(), ForceBase::forces_, CoulombPotential< T >::is_active, and OperatorBase::value_.
|
inlineoverridevirtual |
write about the class
Implements OperatorBase.
Definition at line 358 of file CoulombPotential.h.
References OhmmsElementBase::getName(), CoulombPotential< T >::myTableIndex, and CoulombPotential< T >::Pa.
|
inlineoverridevirtual |
|
inlineoverridevirtual |
Implements OperatorBase.
Definition at line 382 of file CoulombPotential.h.
References CoulombPotential< T >::ComputeForces, CoulombPotential< T >::is_AA, CoulombPotential< T >::is_active, and CoulombPotential< T >::Pa.
|
inlineoverridevirtual |
Read the input parameter.
| cur | xml node for a OperatorBase object |
Implements OperatorBase.
Definition at line 356 of file CoulombPotential.h.
|
inlineoverridevirtual |
Reset the data with the target ParticleSet.
| P | new target ParticleSet |
Implements OperatorBase.
Definition at line 316 of file CoulombPotential.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 367 of file CoulombPotential.h.
References CoulombPotential< T >::ComputeForces, OperatorBase::setObservables(), and ForceBase::setObservablesF().
|
inlineoverridevirtual |
Reimplemented from OperatorBase.
Definition at line 374 of file CoulombPotential.h.
References CoulombPotential< T >::ComputeForces, OperatorBase::setParticlePropertyList(), and ForceBase::setParticleSetF().
|
inlineoverridevirtual |
Update data associated with a particleset.
Default implementation does nothing. Only A-A interactions for s needs to implement its own method.
| s | source particle set |
Reimplemented from OperatorBase.
Definition at line 323 of file CoulombPotential.h.
References CoulombPotential< T >::evaluateAA(), CoulombPotential< T >::is_AA, CoulombPotential< T >::myTableIndex, qmcplusplus::Units::time::s, and OperatorBase::value_.
| bool ComputeForces |
Flag for whether to compute forces or not.
Definition at line 58 of file CoulombPotential.h.
Referenced by CoulombPotential< T >::addObservables(), CoulombPotential< T >::CoulombPotential(), CoulombPotential< T >::makeClone(), CoulombPotential< T >::setObservables(), and CoulombPotential< T >::setParticlePropertyList().
| const bool is_AA |
true if the table is AA
Definition at line 46 of file CoulombPotential.h.
Referenced by CoulombPotential< T >::checkoutParticleQuantities(), CoulombPotential< T >::deleteParticleQuantities(), CoulombPotential< T >::evaluate(), CoulombPotential< T >::makeClone(), and CoulombPotential< T >::updateSource().
| bool is_active |
true, if CoulombAA for quantum particleset
Definition at line 48 of file CoulombPotential.h.
Referenced by CoulombPotential< T >::checkoutParticleQuantities(), CoulombPotential< T >::CoulombPotential(), CoulombPotential< T >::evaluate(), CoulombPotential< T >::evaluateWithIonDerivs(), and CoulombPotential< T >::makeClone().
| const int myTableIndex |
distance table index
Definition at line 44 of file CoulombPotential.h.
Referenced by CoulombPotential< T >::checkoutParticleQuantities(), CoulombPotential< T >::CoulombPotential(), CoulombPotential< T >::evaluate(), CoulombPotential< T >::get(), and CoulombPotential< T >::updateSource().
| int nCenters |
number of centers
Definition at line 50 of file CoulombPotential.h.
Referenced by CoulombPotential< T >::CoulombPotential(), CoulombPotential< T >::evaluate_spAA(), CoulombPotential< T >::evaluate_spAB(), CoulombPotential< T >::evaluateAA(), CoulombPotential< T >::evaluateAAForces(), and CoulombPotential< T >::evaluateAB().
| ParticleSet& Pa |
source particle set
Definition at line 40 of file CoulombPotential.h.
Referenced by CoulombPotential< T >::checkoutParticleQuantities(), CoulombPotential< T >::evaluate(), CoulombPotential< T >::get(), and CoulombPotential< T >::makeClone().
| ParticleSet& Pb |
target particle set
Definition at line 42 of file CoulombPotential.h.
Referenced by CoulombPotential< T >::checkoutParticleQuantities().
single particle trace samples
Definition at line 53 of file CoulombPotential.h.
Referenced by CoulombPotential< T >::checkoutParticleQuantities(), CoulombPotential< T >::deleteParticleQuantities(), CoulombPotential< T >::evaluate_spAA(), and CoulombPotential< T >::evaluate_spAB().
Definition at line 54 of file CoulombPotential.h.
Referenced by CoulombPotential< T >::checkoutParticleQuantities(), CoulombPotential< T >::deleteParticleQuantities(), and CoulombPotential< T >::evaluate_spAB().