![]() |
QMCPACK
|
"Estimator" to produce files for orbital plotting. More...
Public Member Functions | |
OrbitalImages (ParticleSet &P, const PSPool &PSP, Communicate *mpicomm, const SPOMap &spomap) | |
OrbitalImages (const OrbitalImages &other) | |
std::string | getClassName () const override |
return class name More... | |
std::unique_ptr< OperatorBase > | makeClone (ParticleSet &P, TrialWaveFunction &psi) final |
bool | put (xmlNodePtr cur) override |
read xml input More... | |
Return_t | evaluate (ParticleSet &P) override |
hijack estimator evaluate to evaluate and write all orbitals More... | |
void | addObservables (PropertySetType &plist, BufferType &olist) override |
named values to the property list Default implementaton uses addValue(plist_) More... | |
void | registerCollectables (std::vector< ObservableHelper > &h5desc, hdf_archive &file) const override |
void | resetTargetParticleSet (ParticleSet &P) override |
Reset the data with the target ParticleSet. 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 |
void | checkout_scalar_arrays (TraceManager &tm) |
void | collect_scalar_samples () |
void | delete_scalar_arrays () |
bool | get (std::ostream &os) const override |
write about the class More... | |
void | report (const std::string &pad) |
write brief report of configuration data More... | |
void | write_orbital (const std::string &sponame, int index, std::vector< ValueType > &orb, value_types_enum value_type, derivative_types_enum derivative_type=value_d, int dimension=0) |
write a single orbital to file More... | |
void | write_orbital_xsf (const std::string &sponame, int index, std::vector< ValueType > &orb, value_types_enum value_type, derivative_types_enum derivative_type=value_d, int dimension=0) |
write a single orbital to an xsf file More... | |
![]() | |
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 | 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... | |
Public Attributes | |
const PSPool & | psetpool |
at put() ion particleset is obtained from ParticleSetPool More... | |
ParticleSet * | Peln |
electron particleset More... | |
ParticleSet * | Pion |
ion particleset More... | |
Communicate * | comm |
mpi communicator More... | |
formats_enum | format |
file format selection More... | |
std::vector< value_types_enum > | value_types |
orbital value selections More... | |
bool | derivatives |
write out derivatives in addition to values More... | |
std::vector< std::string > | sposet_names |
names of sposets to evaluate More... | |
const std::shared_ptr< std::vector< std::vector< int > > > | sposet_indices |
indices of orbitals within each sposet to evaluate More... | |
std::vector< std::unique_ptr< SPOSet > > | sposets |
sposets obtained by name from SPOMap More... | |
bool | center_grid |
evaluate points at grid cell centers instead of edges More... | |
Lattice_t | cell |
cell bounding the evaluation grid, default is simulation cell More... | |
PosType | corner |
location of cell corner, positions in the cell are corner+uvec*cell More... | |
TinyVector< int, DIM > | grid |
number of grid points in each direction (cell axis) More... | |
TinyVector< int, DIM > | gdims |
stride to generate grid in arbitrary dimensions More... | |
int | npoints |
total number of grid points More... | |
int | batch_size |
number of orbitals to store in memory at a time (batch_size*npoints) More... | |
ValueVector | spo_vtmp |
temporary vector to hold values of all orbitals at a single point More... | |
GradVector | spo_gtmp |
temporary vector to hold gradients of all orbitals at a single point More... | |
ValueVector | spo_ltmp |
temporary vector to hold laplacians of all orbitals at a single point More... | |
Array< ValueType, 2 > | batch_values |
temporary array to hold values of a batch of orbitals at all grid points More... | |
Array< GradType, 2 > | batch_gradients |
temporary array to hold gradients of a batch of orbitals at all grid points More... | |
Array< ValueType, 2 > | batch_laplacians |
temporary array to hold laplacians of a batch of orbitals at all grid points More... | |
std::vector< ValueType > | orbital |
temporary array to hold values of a single orbital at all grid points More... | |
Private Attributes | |
const SPOMap & | spomap_ |
reference to the sposet_builder_factory More... | |
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_ |
"Estimator" to produce files for orbital plotting.
Orbitals are evaluated on a uniform grid and written to ascii files. Only format currently supported is xsf (XCrySDen). Can print real, imag, abs, and abs^2 of each orbital. This class should work with any SPOSet. All work is performed by omp thread 0 of mpi task 0.
TO USE THIS YOU NEED TO KNOW THE NAME OF THE SPOSET(S)!!! For example, using sposet_builder the names are prominently displayed:
<sposet_builder type="bspline" href="pwscf.h5" tilematrix="1 0 0 0 1 0 0 0 1" twistnum="0" source="ion0" version="0.10"> <sposet type="bspline" name="spo_ud" size="2" spindataset="0"> </sposet_builder>
In this case a single sposet named "spo_ud" exists.
If you are using Slater-Jastrow w/o sposet_builder the sposets should be named updet and downdet.
To make xsf files, add xml similar to the following to <hamiltonian>:
minimal working example: single sposet named spo_ud on a 20x20x20 grid
<estimator name="OrbitalImages" type="orbitalimages" ions="ion0"> <parameter name="sposets"> spo_ud </parameter> <parameter name="grid"> 20 20 20 </parameter> </estimator>
as above, but print real, imag, abs, and abs^2 of orbitals (default real)
<estimator name="OrbitalImages" type="orbitalimages" ions="ion0"> <parameter name="sposets"> spo_ud </parameter> <parameter name="grid"> 20 20 20 </parameter> <parameter name="value"> real imag abs abs2 </parameter> </estimator>
up and down sposets named spo_u and spo_d w/ individual orbitals selected
<estimator name="OrbitalImages" type="orbitalimages" ions="ion0"> <parameter name="sposets"> spo_u spo_d </parameter> <parameter name="spo_u"> 13 24 37 </parameter> <parameter name="spo_d"> 10 18 29 41 </parameter> <parameter name="grid"> 20 20 20 </parameter> <parameter name="value"> real imag abs abs2 </parameter> </estimator>
user defined cell by cell center and axes (openbc's, subset of pbc cell)
<estimator name="OrbitalImages" type="orbitalimages" ions="ion0"> <parameter name="sposets"> spo_ud </parameter> <parameter name="grid"> 20 20 20 </parameter> <parameter name="center"> 2.5 2.5 2.5 </parameter> <parameter name="cell"> 5.0 0.0 0.0 0.0 5.0 0.0 0.0 0.0 5.0 </parameter> </estimator>
user defined cell by cell corner and axes (default corner is 0 0 0)
<estimator name="OrbitalImages" type="orbitalimages" ions="ion0"> <parameter name="sposets"> spo_ud </parameter> <parameter name="grid"> 20 20 20 </parameter> <parameter name="corner"> 0.0 0.0 0.0 </parameter> <parameter name="cell"> 5.0 0.0 0.0 0.0 5.0 0.0 0.0 0.0 5.0 </parameter> </estimator>
store only a batch of orbital values in memory this can save on memory for very large grids but will evaluate all orbitals #orbitals/batch_size times
<estimator name="OrbitalImages" type="orbitalimages" ions="ion0"> <parameter name="sposets"> spo_ud </parameter> <parameter name="grid"> 200 200 200 </parameter> <parameter name="batch_size"> 10 </parameter> </estimator>
Definition at line 106 of file OrbitalImages.h.
using GradVector = SPOSet::GradVector |
Definition at line 115 of file OrbitalImages.h.
using Lattice_t = ParticleSet::ParticleLayout |
Definition at line 116 of file OrbitalImages.h.
using PSPool = std::map<std::string, const std::unique_ptr<ParticleSet> > |
Definition at line 117 of file OrbitalImages.h.
using ValueVector = SPOSet::ValueVector |
Definition at line 114 of file OrbitalImages.h.
anonymous enum |
derivative types
Enumerator | |
---|---|
value_d | |
gradient_d | |
laplacian_d |
Definition at line 120 of file OrbitalImages.h.
enum formats_enum |
options for orbital output file format
Enumerator | |
---|---|
xsf |
Definition at line 138 of file OrbitalImages.h.
enum value_types_enum |
options for orbital value to write
Enumerator | |
---|---|
real_val | |
imag_val | |
abs_val | |
abs2_val |
Definition at line 129 of file OrbitalImages.h.
OrbitalImages | ( | ParticleSet & | P, |
const PSPool & | PSP, | ||
Communicate * | mpicomm, | ||
const SPOMap & | spomap | ||
) |
Definition at line 22 of file OrbitalImages.cpp.
References OrbitalImages::comm, and OrbitalImages::Peln.
OrbitalImages | ( | const OrbitalImages & | other | ) |
Definition at line 32 of file OrbitalImages.cpp.
References OrbitalImages::sposets.
|
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 235 of file OrbitalImages.h.
|
inline |
Definition at line 243 of file OrbitalImages.h.
|
inline |
Definition at line 244 of file OrbitalImages.h.
|
inline |
Definition at line 245 of file OrbitalImages.h.
|
overridevirtual |
hijack estimator evaluate to evaluate and write all orbitals
Implements OperatorBase.
Definition at line 306 of file OrbitalImages.cpp.
References APP_ABORT, qmcplusplus::app_log(), Communicate::barrier(), OrbitalImages::batch_gradients, OrbitalImages::batch_laplacians, OrbitalImages::batch_size, OrbitalImages::batch_values, OrbitalImages::cell, OrbitalImages::center_grid, OrbitalImages::comm, OrbitalImages::corner, OrbitalImages::derivatives, OrbitalImages::DIM, SPOSet::evaluateValue(), SPOSet::evaluateVGL(), OrbitalImages::gdims, OrbitalImages::gradient_d, OrbitalImages::grid, OrbitalImages::laplacian_d, ParticleSet::makeMove(), omptarget::min(), OrbitalImages::npoints, omp_get_thread_num(), OrbitalImages::orbital, ParticleSet::R, Communicate::rank(), ParticleSet::rejectMove(), Array< T, D, ALLOC >::resize(), SPOSet::size(), OrbitalImages::spo_gtmp, OrbitalImages::spo_ltmp, OrbitalImages::spo_vtmp, OrbitalImages::sposet_names, OrbitalImages::sposets, CrystalLattice< T, D >::toCart(), OrbitalImages::value_types, and OrbitalImages::write_orbital().
|
inlineoverridevirtual |
|
inlineoverridevirtual |
|
finalvirtual |
Implements OperatorBase.
Definition at line 63 of file OrbitalImages.cpp.
References qmcplusplus::clone.
|
overridevirtual |
read xml input
Implements OperatorBase.
Definition at line 72 of file OrbitalImages.cpp.
References OrbitalImages::abs2_val, OrbitalImages::abs_val, OhmmsAttributeSet::add(), APP_ABORT, qmcplusplus::app_log(), OrbitalImages::batch_size, OrbitalImages::cell, CrystalLattice< T, D >::Center, OrbitalImages::center_grid, OrbitalImages::corner, OrbitalImages::derivatives, OrbitalImages::DIM, OrbitalImages::format, OrbitalImages::gdims, ParticleSet::get(), ParticleSet::getLattice(), getXMLAttributeValue(), OrbitalImages::grid, OrbitalImages::imag_val, qmcplusplus::n, OperatorBase::name_, OrbitalImages::npoints, OrbitalImages::Peln, OrbitalImages::Pion, OrbitalImages::psetpool, OhmmsAttributeSet::put(), putContent(), OrbitalImages::real_val, OrbitalImages::report(), CrystalLattice< T, D >::set(), OrbitalImages::spomap_, OrbitalImages::sposet_indices, OrbitalImages::sposet_names, OrbitalImages::sposets, OrbitalImages::value_types, and OrbitalImages::xsf.
|
inlineoverridevirtual |
void report | ( | const std::string & | pad | ) |
write brief report of configuration data
Definition at line 273 of file OrbitalImages.cpp.
References qmcplusplus::app_log(), OrbitalImages::cell, CrystalLattice< T, D >::Center, OrbitalImages::center_grid, OrbitalImages::corner, OrbitalImages::derivatives, OrbitalImages::DIM, OrbitalImages::grid, qmcplusplus::n, OrbitalImages::npoints, CrystalLattice< T, D >::Rv, SPOSet::size(), OrbitalImages::sposet_indices, OrbitalImages::sposet_names, and OrbitalImages::sposets.
Referenced by OrbitalImages::put().
|
inlineoverridevirtual |
Reset the data with the target ParticleSet.
P | new target ParticleSet |
Implements OperatorBase.
Definition at line 239 of file OrbitalImages.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 240 of file OrbitalImages.h.
|
inlineoverridevirtual |
void write_orbital | ( | const std::string & | sponame, |
int | index, | ||
std::vector< ValueType > & | orb, | ||
value_types_enum | value_type, | ||
derivative_types_enum | derivative_type = value_d , |
||
int | dimension = 0 |
||
) |
write a single orbital to file
Definition at line 440 of file OrbitalImages.cpp.
References OrbitalImages::format, OrbitalImages::write_orbital_xsf(), and OrbitalImages::xsf.
Referenced by OrbitalImages::evaluate().
void write_orbital_xsf | ( | const std::string & | sponame, |
int | index, | ||
std::vector< ValueType > & | orb, | ||
value_types_enum | value_type, | ||
derivative_types_enum | derivative_type = value_d , |
||
int | dimension = 0 |
||
) |
write a single orbital to an xsf file
Definition at line 453 of file OrbitalImages.cpp.
References qmcplusplus::Units::distance::A, qmcplusplus::Units::A, qmcplusplus::abs(), OrbitalImages::abs2_val, OrbitalImages::abs_val, APP_ABORT, qmcplusplus::app_log(), B(), qmcplusplus::Units::B, OrbitalImages::cell, qmcplusplus::convert(), qmcplusplus::Units::convert(), OrbitalImages::corner, OrbitalImages::DIM, ParticleSet::getLattice(), ParticleSet::getTotalNum(), OrbitalImages::gradient_d, OrbitalImages::grid, qmcplusplus::imag(), OrbitalImages::imag_val, OrbitalImages::laplacian_d, OrbitalImages::npoints, OrbitalImages::Peln, OrbitalImages::Pion, ParticleSet::R, qmcplusplus::real(), OrbitalImages::real_val, CrystalLattice< T, D >::Rv, ParticleSet::species_from_index(), qmcplusplus::SUPERCELL_BULK, and OrbitalImages::value_d.
Referenced by OrbitalImages::write_orbital().
temporary array to hold gradients of a batch of orbitals at all grid points
Definition at line 208 of file OrbitalImages.h.
Referenced by OrbitalImages::evaluate().
temporary array to hold laplacians of a batch of orbitals at all grid points
Definition at line 211 of file OrbitalImages.h.
Referenced by OrbitalImages::evaluate().
int batch_size |
number of orbitals to store in memory at a time (batch_size*npoints)
Definition at line 193 of file OrbitalImages.h.
Referenced by OrbitalImages::evaluate(), and OrbitalImages::put().
temporary array to hold values of a batch of orbitals at all grid points
Definition at line 205 of file OrbitalImages.h.
Referenced by OrbitalImages::evaluate().
Lattice_t cell |
cell bounding the evaluation grid, default is simulation cell
Definition at line 178 of file OrbitalImages.h.
Referenced by OrbitalImages::evaluate(), OrbitalImages::put(), OrbitalImages::report(), and OrbitalImages::write_orbital_xsf().
bool center_grid |
evaluate points at grid cell centers instead of edges
Definition at line 175 of file OrbitalImages.h.
Referenced by OrbitalImages::evaluate(), OrbitalImages::put(), and OrbitalImages::report().
Communicate* comm |
mpi communicator
Definition at line 153 of file OrbitalImages.h.
Referenced by OrbitalImages::evaluate(), and OrbitalImages::OrbitalImages().
PosType corner |
location of cell corner, positions in the cell are corner+uvec*cell
Definition at line 181 of file OrbitalImages.h.
Referenced by OrbitalImages::evaluate(), OrbitalImages::put(), OrbitalImages::report(), and OrbitalImages::write_orbital_xsf().
bool derivatives |
write out derivatives in addition to values
Definition at line 163 of file OrbitalImages.h.
Referenced by OrbitalImages::evaluate(), OrbitalImages::put(), and OrbitalImages::report().
formats_enum format |
file format selection
Definition at line 157 of file OrbitalImages.h.
Referenced by OrbitalImages::put(), and OrbitalImages::write_orbital().
TinyVector<int, DIM> gdims |
stride to generate grid in arbitrary dimensions
Definition at line 187 of file OrbitalImages.h.
Referenced by OrbitalImages::evaluate(), and OrbitalImages::put().
TinyVector<int, DIM> grid |
number of grid points in each direction (cell axis)
Definition at line 184 of file OrbitalImages.h.
Referenced by OrbitalImages::evaluate(), OrbitalImages::put(), OrbitalImages::report(), and OrbitalImages::write_orbital_xsf().
int npoints |
total number of grid points
Definition at line 190 of file OrbitalImages.h.
Referenced by OrbitalImages::evaluate(), OrbitalImages::put(), OrbitalImages::report(), and OrbitalImages::write_orbital_xsf().
std::vector<ValueType> orbital |
temporary array to hold values of a single orbital at all grid points
Definition at line 214 of file OrbitalImages.h.
Referenced by OrbitalImages::evaluate().
ParticleSet* Peln |
electron particleset
Definition at line 147 of file OrbitalImages.h.
Referenced by OrbitalImages::OrbitalImages(), OrbitalImages::put(), and OrbitalImages::write_orbital_xsf().
ParticleSet* Pion |
ion particleset
Definition at line 150 of file OrbitalImages.h.
Referenced by OrbitalImages::put(), and OrbitalImages::write_orbital_xsf().
const PSPool& psetpool |
at put() ion particleset is obtained from ParticleSetPool
Definition at line 144 of file OrbitalImages.h.
Referenced by OrbitalImages::put().
GradVector spo_gtmp |
temporary vector to hold gradients of all orbitals at a single point
Definition at line 199 of file OrbitalImages.h.
Referenced by OrbitalImages::evaluate().
ValueVector spo_ltmp |
temporary vector to hold laplacians of all orbitals at a single point
Definition at line 202 of file OrbitalImages.h.
Referenced by OrbitalImages::evaluate().
ValueVector spo_vtmp |
temporary vector to hold values of all orbitals at a single point
Definition at line 196 of file OrbitalImages.h.
Referenced by OrbitalImages::evaluate().
|
private |
reference to the sposet_builder_factory
Definition at line 273 of file OrbitalImages.h.
Referenced by OrbitalImages::put().
const std::shared_ptr<std::vector<std::vector<int> > > sposet_indices |
indices of orbitals within each sposet to evaluate
Definition at line 169 of file OrbitalImages.h.
Referenced by OrbitalImages::put(), and OrbitalImages::report().
std::vector<std::string> sposet_names |
names of sposets to evaluate
Definition at line 166 of file OrbitalImages.h.
Referenced by OrbitalImages::evaluate(), OrbitalImages::put(), and OrbitalImages::report().
std::vector<std::unique_ptr<SPOSet> > sposets |
sposets obtained by name from SPOMap
Definition at line 172 of file OrbitalImages.h.
Referenced by OrbitalImages::evaluate(), OrbitalImages::OrbitalImages(), OrbitalImages::put(), and OrbitalImages::report().
std::vector<value_types_enum> value_types |
orbital value selections
Definition at line 160 of file OrbitalImages.h.
Referenced by OrbitalImages::evaluate(), and OrbitalImages::put().