MADNESS 0.10.1
molecule.h
Go to the documentation of this file.
1/*
2 This file is part of MADNESS.
3
4 Copyright (C) 2007,2010 Oak Ridge National Laboratory
5
6 This program is free software; you can redistribute it and/or modify
7 it under the terms of the GNU General Public License as published by
8 the Free Software Foundation; either version 2 of the License, or
9 (at your option) any later version.
10
11 This program is distributed in the hope that it will be useful,
12 but WITHOUT ANY WARRANTY; without even the implied warranty of
13 MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the
14 GNU General Public License for more details.
15
16 You should have received a copy of the GNU General Public License
17 along with this program; if not, write to the Free Software
18 Foundation, Inc., 59 Temple Place, Suite 330, Boston, MA 02111-1307 USA
19
20 For more information please contact:
21
22 Robert J. Harrison
23 Oak Ridge National Laboratory
24 One Bethel Valley Road
25 P.O. Box 2008, MS-6367
26
27 email: harrisonrj@ornl.gov
28 tel: 865-241-3937
29 fax: 865-572-0680
30*/
31
32#ifndef MADNESS_CHEM_MOLECULE_H__INCLUDED
33#define MADNESS_CHEM_MOLECULE_H__INCLUDED
34
35/// \file moldft/molecule.h
36/// \brief Declaration of molecule related classes and functions
37
38#include <ctype.h>
41#include <madness/misc/misc.h>
44
45#include <algorithm>
46#include <cmath>
47#include <fstream>
48#include <iostream>
49#include <sstream>
50#include <string>
51#include <vector>
52
55
56namespace madness {
57
58class World;
59
60class Atom {
61 public:
62 double x, y, z, q; ///< Coordinates and charge in atomic units
63 unsigned int atomic_number; ///< Atomic number
64 double mass; ///< Mass
65 bool pseudo_atom; ///< Indicates if this atom uses a pseudopotential
66
67 explicit Atom(double x, double y, double z, double q, unsigned int atomic_number, bool pseudo_atom)
70
71 if (mass == -1.0) MADNESS_EXCEPTION("faulty element in Atom", 1);
72
73 // unstable elements are indicated by negative masses, the mass
74 // is taken from the longest-living element
75 if (mass < 0.0) mass *= -1.0;
76 }
77
78 explicit Atom(double x, double y, double z, double q, unsigned int atomic_number) : x(x), y(y), z(z), q(q), atomic_number(atomic_number) {
80
81 if (mass == -1.0) MADNESS_EXCEPTION("faulty element in Atom", 1);
82
83 // unstable elements are indicated by negative masses, the mass
84 // is taken from the longest-living element
85 if (mass < 0.0) mass *= -1.0;
86
87 pseudo_atom = false;
88 }
89
91
92 /// Default construct makes a zero charge ghost atom at origin
93 Atom() : x(0), y(0), z(0), q(0), atomic_number(0), mass(0.0), pseudo_atom(false) {}
94
95 bool operator==(const Atom &other) const {
96 double thresh=1.e-10;
97 auto displacement=Vector<double, 3>({x, y, z})-(Vector<double, 3>({other.x, other.y, other.z}));
98 double err = displacement.normf();
99 return ((err<thresh) && q == other.q &&
100 atomic_number == other.atomic_number && mass == other.mass &&
101 pseudo_atom == other.pseudo_atom);
102 }
103
104 int get_atomic_number() const { return atomic_number; }
105
107
108 /// return the mass in atomic units (electron mass = 1 a.u.)
110
111 template <typename Archive>
112 void serialize(Archive &ar) {
113 ar & x & y & z & q & atomic_number & mass & pseudo_atom;
114 }
115 hashT hash() const {
116 hashT h = hash_value(x);
117 hash_combine(h, y);
118 hash_combine(h, z);
119 hash_combine(h, q);
123 return h;
124 }
125};
126
127std::ostream &operator<<(std::ostream &s, const Atom &atom);
128
129class Molecule {
130 public:
131 // Needed for ParameterManager
132 static constexpr char const *tag = "molecule";
133 [[nodiscard]] json to_json_if_precedence(std::string const &precedence) const {
134 json mol_schema = to_json();
135 mol_schema["parameters"] = parameters.to_json_if_precedence(precedence);
136 insert_symbols_and_geometry(mol_schema);
137 return mol_schema;
138 }
139
140
142 GeometryParameters(const GeometryParameters &other) = default;
143
145 try {
147 read_input_and_commandline_options(world, parser, "geometry");
148 set_derived_values(parser);
149
150 } catch (std::exception &e) {
151 print(tag, "end");
152 throw;
153 // MADNESS_EXCEPTION("faulty geometry input",1);
154 }
155 }
156
158 ignore_unknown_keys = true;
161
162 // initialize<std::vector<std::string>>("source",{"inputfile"},"where
163 // to get the coordinates from: ({inputfile}, {library,xxx},
164 // {xyz,xxx.xyz})");
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");
176
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");
180 }
181
182 std::string get_tag() const override {
183 return std::string("geometry");
184 }
185
187 if (parser.key_exists("geometry")) {
188 set_user_defined_value("source_name", parser.value("geometry"));
189 }
190 }
191
193 // check if we use an xyz file, the structure library or the input file
194 set_derived_value("source_name",
195 parser.value("input")); // will not override user input
196 std::string src_type = derive_source_type_from_name(source_name(), parser);
197 set_derived_value("source_type", src_type);
198 if (parser.key_exists("no_orient") and parser.value("no_orient") == "true") set_derived_value("no_orient", true);
199
200 // check for ambiguities in the derived source type
201 if (not is_user_defined("source_type")) {
202 std::ifstream f(source_name().c_str());
203 bool found_geometry_file = f.good();
204 // bool
205 // found_geometry_file=std::filesystem::exists(source_name());
206
207 bool geometry_found_in_library = true;
208 try { // check for existence of file and structure in the library
209 std::ifstream f;
211 } catch (...) {
212 geometry_found_in_library = false;
213 }
214
215 if (found_geometry_file and geometry_found_in_library) {
216 madness::print("\n\n");
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");
225 madness::print(" source_type xyz");
226 madness::print(" source_type library\n\n");
227 MADNESS_EXCEPTION("faulty input\n\n", 1);
228 }
229 }
230
231 // std::vector<std::string> src=source();
232 //
233 // // some convenience for the user
234 //
235 // // if source is the input file provide the name of the input
236 // file if (src.size()==1 and src[0]=="inputfile")
237 // set_derived_value("source",std::vector<std::string>({src[0],parser.value("input")}));
238 // // if source is not "inputfile" or "library" assume an xyz
239 // file if (src.size()==1 and src[0]!="inputfile") {
240 // std::size_t found=src[0].find("xyz");
241 // if (found==src[0].size()-3) { // check input file ends
242 // with xyz
243 // set_user_defined_value("source",
244 // std::vector<std::string>({"xyz", src[0]}));
245 // } else {
246 // throw std::runtime_error("error in deriving geometry
247 // parameters");
248 // }
249 // }
250
251 if (source_type() == "xyz") set_derived_value("units", std::string("angstrom"));
252 if (units() == "bohr" or units() == "au") set_derived_value("units", std::string("atomic"));
253 }
254
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"); }
265
266 static std::string derive_source_type_from_name(const std::string name, const commandlineparser &parser) {
267 if (name == parser.value("input")) return "inputfile";
268 std::size_t pos = name.find(".xyz");
269 if (pos != std::string::npos) return "xyz";
270 return "library";
271 }
272 };
273
274 private:
275 // If you add more fields don't forget to serialize them
276 std::vector<Atom> atoms;
277 std::vector<double> rcut; // Reciprocal of the smoothing radius
280
281 /// The molecular point group is automatically assigned in the
282 /// identify_pointgroup function
283 std::string pointgroup_ = "c1";
284
285 public:
287
288 static void print_parameters();
289
290 std::string get_pointgroup() const { return pointgroup_; }
291
292 private:
293 void swapaxes(int ix, int iy);
294
295 template <typename opT>
296 bool test_for_op(opT op, const double symtol) const;
297
298 template <typename opT>
299 void symmetrize_for_op(opT op, const double symtol);
300
301 template <typename opT>
302 int find_symmetry_equivalent_atom(int iatom, opT op, const double symtol) const;
303
304 bool test_for_c2(double xaxis, double yaxis, double zaxis, const double symtol) const;
305
306 bool test_for_sigma(double xaxis, double yaxis, double zaxis, const double symtol) const;
307
308 bool test_for_inverse(const double symtol) const;
309
310 /// Apply to (x,y,z) a C2 rotation about an axis thru the origin and
311 /// (xaxis,yaxis,zaxis)
312 struct apply_c2 {
313 double xaxis, yaxis, zaxis;
314 apply_c2(double xaxis, double yaxis, double zaxis) : xaxis(xaxis), yaxis(yaxis), zaxis(zaxis) {}
315 void operator()(double &x, double &y, double &z) const {
316 double raxissq = xaxis * xaxis + yaxis * yaxis + zaxis * zaxis;
317 double dx = x * xaxis * xaxis / raxissq;
318 double dy = y * yaxis * yaxis / raxissq;
319 double dz = z * zaxis * zaxis / raxissq;
320 x = 2.0 * dx - x;
321 y = 2.0 * dy - y;
322 z = 2.0 * dz - z;
323 }
324 };
325
326 /// Apply to (x,y,z) a reflection through a plane containing the origin with
327 /// normal (xaxis,yaxis,zaxis)
328 struct apply_sigma {
329 double xaxis, yaxis, zaxis;
330 apply_sigma(double xaxis, double yaxis, double zaxis) : xaxis(xaxis), yaxis(yaxis), zaxis(zaxis) {}
331 void operator()(double &x, double &y, double &z) const {
332 double raxissq = xaxis * xaxis + yaxis * yaxis + zaxis * zaxis;
333 double dx = x * xaxis * xaxis / raxissq;
334 double dy = y * yaxis * yaxis / raxissq;
335 double dz = z * zaxis * zaxis / raxissq;
336
337 x = x - 2.0 * dx;
338 y = y - 2.0 * dy;
339 z = z - 2.0 * dz;
340 }
341 };
342
344 double xaxis, yaxis, zaxis;
345 apply_inverse(double xaxis, double yaxis, double zaxis) : xaxis(xaxis), yaxis(yaxis), zaxis(zaxis) {}
346 void operator()(double &x, double &y, double &z) const {
347 x = -x;
348 y = -y;
349 z = -z;
350 }
351 };
352
353 public:
354 /// Makes a molecule with zero atoms
355 Molecule() : atoms(), rcut(), core_pot(), field(3L){};
356
357 /// makes a molecule from a list of atoms
359
360 /// makes a molecule using contents of \p parser
361 Molecule(World &world, const commandlineparser &parser);
362
363 void get_structure();
364
365 void read_structure_from_library(const std::string &name);
366
367 static std::istream &position_stream_in_library(std::ifstream &f, const std::string &name);
368
369 static std::string get_structure_library_path();
370
371 /// print out a Gaussian cubefile header
372
373 /// @param[in] offset the offset to be subtracted from the coordinates
374 std::vector<std::string> cubefile_header(const Vector<double, 3> offset = Vector<double, 3>(0.0)) const;
375
376 // initializes Molecule using the contents of file \c filename
377 void read_file(const std::string &filename);
378
379 // initializes Molecule using the contents of stream \c f
380 void read(std::istream &f);
381
382 // initializes Molecule using the contents of file \c filenam assuming an xyz
383 // file
384 void read_xyz(const std::string filename);
385
386 void read_core_file(const std::string &filename);
387
388 std::string guess_file() const { return core_pot.guess_file(); };
389
390 unsigned int n_core_orb_all() const;
391
392 unsigned int n_core_orb(unsigned int atn) const {
393 if (core_pot.is_defined(atn))
394 return core_pot.n_core_orb_base(atn);
395 else
396 return 0;
397 };
398
399 unsigned int get_core_l(unsigned int atn, unsigned int c) const { return core_pot.get_core_l(atn, c); }
400
401 double get_core_bc(unsigned int atn, unsigned int c) const { return core_pot.get_core_bc(atn, c); }
402
403 double core_eval(int atom, unsigned int core, int m, double x, double y, double z) const;
404
405 double core_derivative(int atom, int axis, unsigned int core, int m, double x, double y, double z) const;
406
407 bool is_potential_defined(unsigned int atn) const { return core_pot.is_defined(atn); };
408
409 bool is_potential_defined_atom(int i) const { return core_pot.is_defined(atoms[i].atomic_number); };
410
411 void add_atom(double x, double y, double z, double q, int atn);
412
413 void add_atom(double x, double y, double z, double q, int atn, bool psat);
414
415 size_t natom() const { return atoms.size(); };
416
417 void set_atom_charge(unsigned int i, double zeff);
418
419 unsigned int get_atom_charge(unsigned int i) const;
420
421 unsigned int get_atomic_number(unsigned int i) const;
422
423 void set_pseudo_atom(unsigned int i, bool psat);
424
425 bool get_pseudo_atom(unsigned int i) const;
426
427 void set_atom_coords(unsigned int i, double x, double y, double z);
428
430
431 std::vector<madness::Vector<double, 3>> get_all_coords_vec() const;
432
433 std::vector<double> atomic_radii;
434
435 void set_all_coords(const madness::Tensor<double> &newcoords);
436
437 void update_rcut_with_eprec(double value);
438
439 void set_rcut(double value);
440
441 std::vector<double> get_rcut() const { return rcut; }
442
443 void set_core_eprec(double value) { core_pot.set_eprec(value); }
444
445 void set_core_rcut(double value) { core_pot.set_rcut(value); }
446
447 double get_eprec() const { return parameters.eprec(); }
448
449 double bounding_cube() const;
450
451 const Atom &get_atom(unsigned int i) const;
452
453 const std::vector<Atom> &get_atoms() const { return atoms; }
454
455 /// print all parameters and the molecular geometry
456 void print(std::ostream& os=std::cout, const bool defined_only=false) const;
457
458 /// print user-defined parameters and the molecular geometry
459 void print_defined_only(std::ostream& os=std::cout) const {
460 this->print(os,true);
461 };
462
463 double inter_atomic_distance(unsigned int i, unsigned int j) const;
464
465 double nuclear_repulsion_energy() const;
466
467 double nuclear_repulsion_derivative(size_t iatom, int axis) const;
468
469 /// compute the nuclear-nuclear contribution to the second derivatives
470
471 /// @param[in] iatom the i-th atom (row of the hessian)
472 /// @param[in] jatom the j-th atom (column of the hessian)
473 /// @param[in] iaxis the xyz axis of the i-th atom
474 /// @param[in] jaxis the xyz axis of the j-th atom
475 /// return the (3*iatom + iaxis, 3*jatom + jaxis) matix element of the hessian
476 double nuclear_repulsion_second_derivative(int iatom, int jatom, int iaxis, int jaxis) const;
477
478 /// return the hessian matrix of the second derivatives d^2/dxdy V
479
480 /// no factor 0.5 included
482
483 /// compute the dipole moment of the nuclei
484
485 /// @param[in] axis the axis (x, y, z)
486 double nuclear_dipole(int axis) const;
487
488 /// compute the derivative of the nuclear dipole wrt a nuclear displacement
489
490 /// @param[in] atom the atom which will be displaced
491 /// @param[in] axis the axis where the atom will be displaced
492 /// @return a vector which all 3 components of the dipole derivative
493 Tensor<double> nuclear_dipole_derivative(const int atom, const int axis) const;
494
495 /// evaluate the nuclear charge density at point `{x,y,z}` using the default
496 /// MADNESS nuclear model. See smoothed_density() for the description
497 /// of the default nuclear model.
498 /// \param x,y,z the point at which the nuclear charge density is evaluated
499 /// \param rscale setting `rscale>1` will make a nucleus larger by a factor of
500 /// \p rscale (in other words, `rcut` is multiplied by the inverse of by this)
501 /// \return the nuclear charge density at point `{x,y,z}`
502 /// \sa smoothed_density()
503 double nuclear_charge_density(double x, double y, double z, double rscale = 1.) const;
504
505 double smallest_length_scale() const;
506
507 std::string symmetrize_and_identify_point_group(const double symtol);
508
509 /// Moves the center of nuclear charge to the origin
510 void center();
511
512 /// rotates the molecule and the external field
513
514 void fix_phase();
515
516 /// @param[in] D the rotation matrix
517 void rotate(const Tensor<double> &D);
518
519 /// translate the molecule
520 void translate(const Tensor<double> &translation);
521
523
524 /// compute the mass-weighting matrix for the hessian
525
526 /// use as
527 /// mass_weighted_hessian=inner(massweights,inner(hessian,massweights));
529 Tensor<double> M(3 * natom(), 3 * natom());
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;
535 }
536 return M;
537 }
538
540
541 void orient(bool verbose = false);
542
543 double total_nuclear_charge() const;
544
545 /// nuclear attraction potential for the whole molecule
546 double nuclear_attraction_potential(double x, double y, double z) const;
547
548 /// nuclear attraction potential for a specific atom in the molecule
549 double atomic_attraction_potential(int iatom, double x, double y, double z) const;
550
551 double molecular_core_potential(double x, double y, double z) const;
552
553 double core_potential_derivative(int atom, int axis, double x, double y, double z) const;
554
555 double nuclear_attraction_potential_derivative(int atom, int axis, double x, double y, double z) const;
556
557 double nuclear_attraction_potential_second_derivative(int atom, int iaxis, int jaxis, double x, double y, double z) const;
558
559 bool operator==(const Molecule& other) const {
560 if (atoms.size() != other.atoms.size() || rcut.size() != other.rcut.size() || pointgroup_ != other.pointgroup_) return false;
561 for (size_t i = 0; i < atoms.size(); ++i) {
562 if (not (atoms[i] == other.atoms[i])) return false;
563 }
564 for (size_t i = 0; i < rcut.size(); ++i) {
565 if (rcut[i] != other.rcut[i]) return false;
566 }
567
568 return (field-other.field).normf()<1.e-13 && parameters == other.parameters;
569 }
570
571 template <typename Archive>
572 void serialize(Archive &ar) {
574 }
575
576 hashT hash() const {
577 hashT h = hash_range(atoms.begin(), atoms.end());
578 hash_combine(h, hash_range(rcut.begin(), rcut.end()));
580 return h;
581 }
582 [[nodiscard]] json to_json() const;
583 void insert_symbols_and_geometry(json &mol_json) const;
584 void from_json(const json &mol_json);
585};
586
587} // namespace madness
588
589#endif
double q(double t)
Definition DKops.h:18
Declaration of utility class and functions for atom.
Definition mentity.h:71
Definition molecule.h:60
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...