32#ifndef MADNESS_CHEM_MOLECULE_H__INCLUDED
33#define MADNESS_CHEM_MOLECULE_H__INCLUDED
99 return ((err<
thresh) &&
q == other.
q &&
111 template <
typename Archive>
132 static constexpr char const *
tag =
"molecule";
150 }
catch (std::exception &
e) {
165 initialize<std::string>(
"source_type",
"inputfile",
"where to get the coordinates from", {
"inputfile",
"xyz",
"library"});
166 initialize<std::string>(
"source_name",
"TBD",
"name of the geometry from the library or the input file");
167 initialize<double>(
"eprec", 1.e-4,
"smoothing for the nuclear potential");
168 initialize<std::string>(
"units",
"atomic",
"coordinate units", {
"atomic",
"angstrom",
"bohr",
"au"});
169 initialize<std::vector<double>>(
"field", {0.0, 0.0, 0.0},
"external electric field");
170 initialize<bool>(
"no_orient",
false,
171 "if true the molecule coordinates will not be "
172 "reoriented and/or symmetrized");
173 initialize<double>(
"symtol", -1.e-2,
174 "distance threshold for determining the "
175 "symmetry-equivalent atoms; negative: old algorithm");
177 initialize<std::string>(
"core_type",
"none",
"core potential type", {
"none",
"mcp"});
178 initialize<bool>(
"psp_calc",
false,
"pseudopotential calculation for all atoms");
179 initialize<bool>(
"pure_ae",
true,
"pure all electron calculation with no pseudo-atoms");
183 return std::string(
"geometry");
195 parser.
value(
"input"));
203 bool found_geometry_file =
f.good();
207 bool geometry_found_in_library =
true;
212 geometry_found_in_library =
false;
215 if (found_geometry_file and geometry_found_in_library) {
218 "geometry specification ambiguous: found geometry in "
219 "the structure library and in a file\n");
223 "\nPlease specify the location of your geometry input "
224 "by one of the two lines:\n");
255 std::string
source_type()
const {
return get<std::string>(
"source_type"); }
256 std::string
source_name()
const {
return get<std::string>(
"source_name"); }
257 std::vector<double>
field()
const {
return get<std::vector<double>>(
"field"); }
258 double eprec()
const {
return get<double>(
"eprec"); }
259 std::string
units()
const {
return get<std::string>(
"units"); }
260 std::string
core_type()
const {
return get<std::string>(
"core_type"); }
261 bool psp_calc()
const {
return get<bool>(
"psp_calc"); }
262 bool pure_ae()
const {
return get<bool>(
"pure_ae"); }
263 bool no_orient()
const {
return get<bool>(
"no_orient"); }
264 double symtol()
const {
return get<double>(
"symtol"); }
267 if (
name == parser.
value(
"input"))
return "inputfile";
268 std::size_t pos =
name.find(
".xyz");
269 if (pos != std::string::npos)
return "xyz";
295 template <
typename opT>
298 template <
typename opT>
301 template <
typename opT>
304 bool test_for_c2(
double xaxis,
double yaxis,
double zaxis,
const double symtol)
const;
306 bool test_for_sigma(
double xaxis,
double yaxis,
double zaxis,
const double symtol)
const;
374 std::vector<std::string>
cubefile_header(
const Vector<double, 3>
offset = Vector<double, 3>(0.0))
const;
380 void read(std::istream &
f);
403 double core_eval(
int atom,
unsigned int core,
int m,
double x,
double y,
double z)
const;
405 double core_derivative(
int atom,
int axis,
unsigned int core,
int m,
double x,
double y,
double z)
const;
411 void add_atom(
double x,
double y,
double z,
double q,
int atn);
413 void add_atom(
double x,
double y,
double z,
double q,
int atn,
bool psat);
456 void print(std::ostream& os=std::cout,
const bool defined_only=
false)
const;
460 this->
print(os,
true);
530 for (
size_t i = 0; i <
natom(); i++) {
531 const double sqrtmass = 1.0 / sqrt(
get_atom(i).get_mass_in_au());
532 M(3 * i, 3 * i) = sqrtmass;
533 M(3 * i + 1, 3 * i + 1) = sqrtmass;
534 M(3 * i + 2, 3 * i + 2) = sqrtmass;
541 void orient(
bool verbose =
false);
561 for (
size_t i = 0; i <
atoms.size(); ++i) {
562 if (not (
atoms[i] == other.
atoms[i]))
return false;
564 for (
size_t i = 0; i <
rcut.size(); ++i) {
565 if (
rcut[i] != other.
rcut[i])
return false;
571 template <
typename Archive>
double q(double t)
Definition DKops.h:18
Declaration of utility class and functions for atom.
Atom(double x, double y, double z, double q, unsigned int atomic_number)
Definition molecule.h:78
double y
Definition molecule.h:62
unsigned int atomic_number
Atomic number.
Definition molecule.h:63
int get_atomic_number() const
Definition molecule.h:104
Atom(double x, double y, double z, double q, unsigned int atomic_number, bool pseudo_atom)
Definition molecule.h:67
double x
Definition molecule.h:62
double z
Definition molecule.h:62
Atom(const Atom &a)
Definition molecule.h:90
bool operator==(const Atom &other) const
Definition molecule.h:95
madness::Vector< double, 3 > get_coords() const
Definition molecule.h:106
Atom()
Default construct makes a zero charge ghost atom at origin.
Definition molecule.h:93
double mass
Mass.
Definition molecule.h:64
double q
Coordinates and charge in atomic units.
Definition molecule.h:62
void serialize(Archive &ar)
Definition molecule.h:112
double get_mass_in_au() const
return the mass in atomic units (electron mass = 1 a.u.)
Definition molecule.h:109
hashT hash() const
Definition molecule.h:115
bool pseudo_atom
Indicates if this atom uses a pseudopotential.
Definition molecule.h:65
Definition corepotential.h:148
unsigned int n_core_orb_base(const unsigned int atn) const
Definition corepotential.h:173
std::string guess_file() const
Definition corepotential.h:177
bool is_defined(const unsigned int atn) const
Definition corepotential.h:165
unsigned int get_core_l(unsigned int atn, unsigned int core) const
Definition corepotential.h:187
void set_eprec(double value)
Definition corepotential.cc:369
void set_rcut(double value)
Definition corepotential.cc:379
double get_core_bc(unsigned int atn, unsigned int core) const
Definition corepotential.h:191
Definition molecule.h:129
void read_structure_from_library(const std::string &name)
Definition molecule.cc:228
std::vector< madness::Vector< double, 3 > > get_all_coords_vec() const
Definition molecule.cc:413
static std::string get_structure_library_path()
Definition molecule.cc:201
std::vector< double > get_rcut() const
Definition molecule.h:441
void read_core_file(const std::string &filename)
Definition molecule.cc:1195
double bounding_cube() const
Returns the half width of the bounding cube.
Definition molecule.cc:1000
std::vector< double > atomic_radii
Definition molecule.h:433
void symmetrize_for_op(opT op, const double symtol)
Definition molecule.cc:740
void update_rcut_with_eprec(double value)
updates rcuts with given eprec
Definition molecule.cc:434
Tensor< double > nuclear_dipole_derivative(const int atom, const int axis) const
compute the derivative of the nuclear dipole wrt a nuclear displacement
Definition molecule.cc:580
void set_all_coords(const madness::Tensor< double > &newcoords)
Definition molecule.cc:424
std::string guess_file() const
Definition molecule.h:388
double smallest_length_scale() const
Definition molecule.cc:680
double get_core_bc(unsigned int atn, unsigned int c) const
Definition molecule.h:401
double atomic_attraction_potential(int iatom, double x, double y, double z) const
nuclear attraction potential for a specific atom in the molecule
Definition molecule.cc:1042
double total_nuclear_charge() const
Definition molecule.cc:1010
double nuclear_dipole(int axis) const
compute the dipole moment of the nuclei
Definition molecule.cc:559
const std::vector< Atom > & get_atoms() const
Definition molecule.h:453
std::vector< Atom > atoms
Definition molecule.h:276
void translate(const Tensor< double > &translation)
translate the molecule
Definition molecule.cc:709
void center()
Moves the center of nuclear charge to the origin.
Definition molecule.cc:690
const Atom & get_atom(unsigned int i) const
Definition molecule.cc:452
bool operator==(const Molecule &other) const
Definition molecule.h:559
madness::Tensor< double > get_all_coords() const
Definition molecule.cc:402
void orient(bool verbose=false)
Centers and orients the molecule in a standard manner.
Definition molecule.cc:908
unsigned int get_atom_charge(unsigned int i) const
Definition molecule.cc:375
double core_derivative(int atom, int axis, unsigned int core, int m, double x, double y, double z) const
Definition molecule.cc:1152
int find_symmetry_equivalent_atom(int iatom, opT op, const double symtol) const
Definition molecule.cc:729
double molecular_core_potential(double x, double y, double z) const
Definition molecule.cc:1165
void print_defined_only(std::ostream &os=std::cout) const
print user-defined parameters and the molecular geometry
Definition molecule.h:459
std::vector< std::string > cubefile_header(const Vector< double, 3 > offset=Vector< double, 3 >(0.0)) const
print out a Gaussian cubefile header
Definition molecule.cc:241
std::string get_pointgroup() const
Definition molecule.h:290
bool get_pseudo_atom(unsigned int i) const
Definition molecule.cc:390
double nuclear_attraction_potential(double x, double y, double z) const
nuclear attraction potential for the whole molecule
Definition molecule.cc:1018
std::string symmetrize_and_identify_point_group(const double symtol)
Definition molecule.cc:796
void read_file(const std::string &filename)
Definition molecule.cc:256
Tensor< double > center_of_mass() const
compute the center of mass
Definition molecule.cc:878
std::string pointgroup_
Definition molecule.h:283
hashT hash() const
Definition molecule.h:576
void fix_phase()
rotates the molecule and the external field
Definition molecule.cc:954
static std::istream & position_stream_in_library(std::ifstream &f, const std::string &name)
Definition molecule.cc:207
void set_atom_coords(unsigned int i, double x, double y, double z)
Definition molecule.cc:395
json to_json_if_precedence(std::string const &precedence) const
Definition molecule.h:133
double inter_atomic_distance(unsigned int i, unsigned int j) const
Definition molecule.cc:531
bool test_for_inverse(const double symtol) const
Definition molecule.cc:779
size_t natom() const
Definition molecule.h:415
double core_eval(int atom, unsigned int core, int m, double x, double y, double z) const
Definition molecule.cc:1143
double nuclear_repulsion_derivative(size_t iatom, int axis) const
Definition molecule.cc:587
std::vector< double > rcut
Definition molecule.h:277
void set_rcut(double value)
Definition molecule.cc:446
void set_core_rcut(double value)
Definition molecule.h:445
void set_core_eprec(double value)
Definition molecule.h:443
bool is_potential_defined(unsigned int atn) const
Definition molecule.h:407
double nuclear_attraction_potential_second_derivative(int atom, int iaxis, int jaxis, double x, double y, double z) const
the second derivative of the (smoothed) nuclear potential Z/r
Definition molecule.cc:1086
void serialize(Archive &ar)
Definition molecule.h:572
double nuclear_repulsion_energy() const
Definition molecule.cc:538
unsigned int get_atomic_number(unsigned int i) const
Definition molecule.cc:380
void swapaxes(int ix, int iy)
Definition molecule.cc:783
static constexpr char const * tag
Definition molecule.h:132
static void print_parameters()
Definition molecule.cc:115
json to_json() const
Definition molecule.cc:462
unsigned int get_core_l(unsigned int atn, unsigned int c) const
Definition molecule.h:399
Tensor< double > nuclear_repulsion_hessian() const
return the hessian matrix of the second derivatives d^2/dxdy V
Definition molecule.cc:607
void add_atom(double x, double y, double z, double q, int atn)
Definition molecule.cc:351
Tensor< double > moment_of_inertia() const
Definition molecule.cc:894
Molecule()
Makes a molecule with zero atoms.
Definition molecule.h:355
double nuclear_charge_density(double x, double y, double z, double rscale=1.) const
Definition molecule.cc:1114
void set_atom_charge(unsigned int i, double zeff)
Definition molecule.cc:370
double get_eprec() const
Definition molecule.h:447
double nuclear_repulsion_second_derivative(int iatom, int jatom, int iaxis, int jaxis) const
compute the nuclear-nuclear contribution to the second derivatives
Definition molecule.cc:631
GeometryParameters parameters
Definition molecule.h:286
void from_json(const json &mol_json)
Definition molecule.cc:483
void print(std::ostream &os=std::cout, const bool defined_only=false) const
print all parameters and the molecular geometry
Definition molecule.cc:510
unsigned int n_core_orb(unsigned int atn) const
Definition molecule.h:392
madness::Tensor< double > field
Definition molecule.h:279
unsigned int n_core_orb_all() const
Definition molecule.cc:1131
void set_pseudo_atom(unsigned int i, bool psat)
Definition molecule.cc:385
void insert_symbols_and_geometry(json &mol_json) const
Definition molecule.cc:473
CorePotentialManager core_pot
Definition molecule.h:278
Tensor< double > massweights() const
compute the mass-weighting matrix for the hessian
Definition molecule.h:528
void get_structure()
Definition molecule.cc:134
bool test_for_c2(double xaxis, double yaxis, double zaxis, const double symtol) const
Definition molecule.cc:771
double core_potential_derivative(int atom, int axis, double x, double y, double z) const
Definition molecule.cc:1180
void read_xyz(const std::string filename)
Definition molecule.cc:306
bool test_for_op(opT op, const double symtol) const
Definition molecule.cc:719
double nuclear_attraction_potential_derivative(int atom, int axis, double x, double y, double z) const
Definition molecule.cc:1055
bool is_potential_defined_atom(int i) const
Definition molecule.h:409
void read(std::istream &f)
Definition molecule.cc:265
bool test_for_sigma(double xaxis, double yaxis, double zaxis, const double symtol) const
Definition molecule.cc:775
void rotate(const Tensor< double > &D)
Definition molecule.cc:983
class for holding the parameters for calculation
Definition QCCalculationParametersBase.h:294
virtual void read_input_and_commandline_options(World &world, const commandlineparser &parser, const std::string tag)
Definition QCCalculationParametersBase.h:330
bool throw_if_datagroup_not_found
Definition QCCalculationParametersBase.h:367
void set_user_defined_value(const std::string &key, const T &value)
Definition QCCalculationParametersBase.h:521
void print(const std::string header="", const std::string footer="") const
print all parameters
Definition QCCalculationParametersBase.cc:22
bool ignore_unknown_keys
Definition QCCalculationParametersBase.h:365
bool ignore_unknown_keys_silently
Definition QCCalculationParametersBase.h:366
bool is_user_defined(std::string key) const
Definition QCCalculationParametersBase.h:313
json to_json_if_precedence(const std::string &precedence) const
convert all parameters to a json object, but only those with a given precedence
Definition QCCalculationParametersBase.h:509
void set_derived_value(const std::string &key, const T &value)
Definition QCCalculationParametersBase.h:408
A tensor is a multidimensional array.
Definition tensor.h:317
A simple, fixed dimension vector.
Definition vector.h:64
A parallel world class.
Definition world.h:132
Declaration of core potential related class.
static const double eprec
Definition hatom_sf_dirac.cc:18
Tensor< double > op(const Tensor< double > &x)
Definition kain.cc:508
#define MADNESS_EXCEPTION(msg, value)
Macro for throwing a MADNESS exception.
Definition madness_exception.h:119
Header to declare stuff which has not yet found a home.
constexpr double atomic_mass_in_au
Atomic mass in atomic units.
Definition constants.h:270
Namespace for all elements and tools of MADNESS.
Definition DFParameters.h:10
std::ostream & operator<<(std::ostream &os, const particle< PDIM > &p)
Definition lowrankfunction.h:401
void hash_range(hashT &seed, It first, It last)
Definition worldhash.h:280
static const char * filename
Definition legendre.cc:96
nlohmann::json json
Definition QCCalculationParametersBase.h:28
void hash_combine(hashT &seed, const T &v)
Combine hash values.
Definition worldhash.h:260
Key< NDIM > displacement(const Key< NDIM > &source, const Key< NDIM > &target)
given a source and a target, return the displacement in translation
Definition key.h:451
const AtomicData & get_atomic_data(unsigned int atomic_number)
Definition atomutil.cc:167
void print(const T &t, const Ts &... ts)
Print items to std::cout (items separated by spaces) and terminate with a new line.
Definition print.h:225
NDIM & f
Definition mra.h:2481
std::size_t hashT
The hash value type.
Definition worldhash.h:145
std::string name(const FuncType &type, const int ex=-1)
Definition ccpairfunction.h:28
madness::hashT hash_value(const std::array< T, N > &a)
Hash std::array with madness hash.
Definition array_addons.h:78
static const double a
Definition nonlinschro.cc:118
static const double c
Definition relops.cc:10
static const double m
Definition relops.cc:9
static const double thresh
Definition rk.cc:45
Definition test_ar.cc:204
const double mass
the atomic mass
Definition atomutil.h:64
Definition molecule.h:141
bool psp_calc() const
Definition molecule.h:261
std::string source_name() const
Definition molecule.h:256
std::string core_type() const
Definition molecule.h:260
void set_global_convenience_options(const commandlineparser &parser)
Definition molecule.h:186
double symtol() const
Definition molecule.h:264
bool no_orient() const
Definition molecule.h:263
static std::string derive_source_type_from_name(const std::string name, const commandlineparser &parser)
Definition molecule.h:266
bool pure_ae() const
Definition molecule.h:262
GeometryParameters(const GeometryParameters &other)=default
std::string get_tag() const override
Definition molecule.h:182
GeometryParameters()
Definition molecule.h:157
GeometryParameters(World &world, const commandlineparser &parser)
Definition molecule.h:144
std::string units() const
Definition molecule.h:259
std::vector< double > field() const
Definition molecule.h:257
double eprec() const
Definition molecule.h:258
std::string source_type() const
Definition molecule.h:255
void set_derived_values(const commandlineparser &parser)
Definition molecule.h:192
Definition molecule.h:312
double yaxis
Definition molecule.h:313
void operator()(double &x, double &y, double &z) const
Definition molecule.h:315
double xaxis
Definition molecule.h:313
apply_c2(double xaxis, double yaxis, double zaxis)
Definition molecule.h:314
double zaxis
Definition molecule.h:313
Definition molecule.h:343
double yaxis
Definition molecule.h:344
void operator()(double &x, double &y, double &z) const
Definition molecule.h:346
double zaxis
Definition molecule.h:344
apply_inverse(double xaxis, double yaxis, double zaxis)
Definition molecule.h:345
double xaxis
Definition molecule.h:344
Definition molecule.h:328
void operator()(double &x, double &y, double &z) const
Definition molecule.h:331
apply_sigma(double xaxis, double yaxis, double zaxis)
Definition molecule.h:330
double xaxis
Definition molecule.h:329
double yaxis
Definition molecule.h:329
double zaxis
Definition molecule.h:329
very simple command line parser
Definition commandlineparser.h:15
std::string value(const std::string key) const
Definition commandlineparser.h:62
bool key_exists(std::string key) const
Definition commandlineparser.h:58
Defines and implements most of Tensor.
void e()
Definition test_sig.cc:75
const double offset
Definition testfuns.cc:143
double h(const coord_1d &r)
Definition testgconv.cc:175
std::size_t axis
Definition testpdiff.cc:59
Implement the madness:Vector class, an extension of std::array that supports some mathematical operat...