33#ifndef MADNESS_CHEM_POTENTIALMANAGER_H__INCLUDED
34#define MADNESS_CHEM_POTENTIALMANAGER_H__INCLUDED
163 template <
typename Int>
166 std::array<Int, 3> lattice_sum_range)
170 rcell_width{1. / cell_width[0], 1. / cell_width[1],
171 1. / cell_width[2]}, lattice_sum_range{lattice_sum_range[0], lattice_sum_range[1], lattice_sum_range[2]} {
172 for (
int d = 0;
d != 3; ++
d)
187 std::array<std::int64_t, 3> result;
188 for (
int d = 0;
d != 3; ++
d) {
189 result[
d] = bc.is_periodic()[
d] ? (range[
d].iextent_x2() + 1) / 2 : 0;
198 const std::array<KernelRange, 3>
range;
220 double smoothing_param,
223 int special_level = 15);
225 double operator()(
const coord_3d& x)
const final;
240 : mol(
molecule), core_type_(core_type) {}
247 return this->core_type_;
256 int npsi =
psi.size();
257 if (npsi == 0)
return psi;
258 int natom = mol.
natom();
262 for (
int i=0; i<natom; ++i) {
266 if (nshell == 0)
continue;
267 for (
unsigned int c=0;
c<nshell; ++
c) {
269 int max_m = (l+1)*(l+2)/2;
271 for (
int m=0;
m<max_m; ++
m) {
274 overlap_sum += overlap;
275 for (
int j=0; j<npsi; ++j) {
277 proj[j] += core.
scale(overlap[j]);
283 if (world.
rank() == 0)
print(
"sum_k <core_k|psi_i>:", overlap_sum);
290 std::vector<double> bc;
295 for (
unsigned int c=0;
c<ncore; ++
c) {
297 int max_m = (l+1)*(l+2)/2;
298 for (
int m=0;
m<max_m; ++
m) {
309 for (
unsigned int c=0;
c<cores.size(); ++
c) {
313 for (
unsigned int i=0; i<mo.size(); ++i) {
314 rcore += rdcores[i] * rcores[i] * occ[i];
316 r += 2.0 * bc[
c] * rcore;
323 if (core_type_.substr(0,3) ==
"mcp") {
325 gaxpy(world, 1.0, Vpsi, 1.0, core_projection(world, amo));
338 if (core_type_ !=
"" && core_type_ !=
"none") {
Declaration of utility class and functions for atom.
unsigned int atomic_number
Atomic number.
Definition molecule.h:61
This class is used to specify boundary conditions for all operators.
Definition bc.h:72
Definition potentialmanager.h:98
double operator()(const coord_3d &r) const
Definition potentialmanager.h:106
CoreOrbitalDerivativeFunctor(Molecule &molecule, int atom, int axis, unsigned int core, int m)
Definition potentialmanager.h:104
const Molecule molecule
Definition potentialmanager.h:99
const int axis
Definition potentialmanager.h:100
const int atom
Definition potentialmanager.h:100
const unsigned int core
Definition potentialmanager.h:101
const int m
Definition potentialmanager.h:102
Definition potentialmanager.h:85
CoreOrbitalFunctor(Molecule &molecule, int atom, unsigned int core, int m)
Definition potentialmanager.h:91
double operator()(const coord_3d &r) const
Definition potentialmanager.h:93
const int m
Definition potentialmanager.h:89
const unsigned int core
Definition potentialmanager.h:88
const int atom
Definition potentialmanager.h:87
const Molecule molecule
Definition potentialmanager.h:86
FunctionDefaults holds default paramaters as static class members.
Definition funcdefaults.h:100
static double thresh
Truncation threshold.
Definition funcdefaults.h:106
Abstract base class interface required for functors used as input to Functions.
Definition function_interface.h:68
Function< T, NDIM > & scale(const Q q, bool fence=true)
Inplace, scale the function by a constant. No communication except for optional fence.
Definition mra.h:995
double thresh() const
Returns value of truncation threshold. No communication.
Definition mra.h:607
void set_thresh(double value, bool fence=true)
Sets the value of the truncation threshold. Optional global fence.
Definition mra.h:617
Function< T, NDIM > & truncate(double tol=0.0, bool fence=true)
Truncate the function with optional fence. Compresses with fence if not compressed.
Definition mra.h:642
const Function< T, NDIM > & reconstruct(bool fence=true) const
Reconstructs the function, transforming into scaling function basis. Possible non-blocking comm.
Definition mra.h:817
Definition kernelrange.h:19
Definition potentialmanager.h:71
std::vector< coord_3d > special_points() const
Override this to return list of special points to be refined more deeply.
Definition potentialmanager.h:82
MolecularCorePotentialFunctor(const Molecule &molecule)
Definition potentialmanager.h:75
double operator()(const coord_3d &x) const
Definition potentialmanager.h:78
const Molecule & molecule
Definition potentialmanager.h:73
Definition potentialmanager.h:57
MolecularPotentialFunctor(const Molecule &molecule)
Definition potentialmanager.h:61
const Molecule & molecule
Definition potentialmanager.h:59
std::vector< coord_3d > special_points() const
Override this to return list of special points to be refined more deeply.
Definition potentialmanager.h:68
double operator()(const coord_3d &x) const
Definition potentialmanager.h:64
Definition molecule.h:124
std::vector< madness::Vector< double, 3 > > get_all_coords_vec() const
Definition molecule.cc:408
double get_core_bc(unsigned int atn, unsigned int c) const
Definition molecule.h:373
const Atom & get_atom(unsigned int i) const
Definition molecule.cc:447
double core_derivative(int atom, int axis, unsigned int core, int m, double x, double y, double z) const
Definition molecule.cc:1094
double molecular_core_potential(double x, double y, double z) const
Definition molecule.cc:1107
double nuclear_attraction_potential(double x, double y, double z) const
nuclear attraction potential for the whole molecule
Definition molecule.cc:960
size_t natom() const
Definition molecule.h:389
double core_eval(int atom, unsigned int core, int m, double x, double y, double z) const
Definition molecule.cc:1085
unsigned int get_core_l(unsigned int atn, unsigned int c) const
Definition molecule.h:369
unsigned int n_core_orb(unsigned int atn) const
Definition molecule.h:362
Default functor for the nuclear charge density.
Definition potentialmanager.h:116
BoundaryConditions< 3 > bc_
Definition potentialmanager.h:119
Level special_level() const final
Override this to change the minimum level of refinement at special points (default is 6)
Definition potentialmanager.cc:89
Tensor< double > cell
Definition potentialmanager.h:120
const Molecule & atoms
Definition potentialmanager.h:118
NuclearDensityFunctor & set_rscale(double rscale)
Definition potentialmanager.cc:93
double rscale
Definition potentialmanager.h:124
double operator()(const coord_3d &x) const final
Definition potentialmanager.cc:61
std::vector< coord_3d > special_points_
Definition potentialmanager.h:121
int maxR
Definition potentialmanager.h:122
std::vector< coord_3d > special_points() const final
Override this to return list of special points to be refined more deeply.
Definition potentialmanager.cc:87
int special_level_
Definition potentialmanager.h:123
Definition potentialmanager.h:232
Molecule mol
Definition potentialmanager.h:234
void apply_nonlocal_potential(World &world, const vector_real_function_3d &amo, vector_real_function_3d Vpsi)
Definition potentialmanager.h:322
const Molecule & molecule() const
Definition potentialmanager.h:242
const real_function_3d & vnuclear()
Definition potentialmanager.h:250
PotentialManager(const Molecule &molecule, const std::string &core_type)
Definition potentialmanager.h:239
const std::string & core_type() const
Definition potentialmanager.h:246
real_function_3d vnuc
Definition potentialmanager.h:235
vector_real_function_3d core_projection(World &world, const vector_real_function_3d &psi, const bool include_Bc=true)
Definition potentialmanager.h:254
double core_projector_derivative(World &world, const vector_real_function_3d &mo, const real_tensor &occ, int atom, int axis)
Definition potentialmanager.h:287
void make_nuclear_potential(World &world)
Definition potentialmanager.h:330
std::string core_type_
Definition potentialmanager.h:236
SAPFunctor = Interpolated Atomic Potential for 1 atom.
Definition potentialmanager.h:205
const Atom & atom
Definition potentialmanager.h:207
Level special_level_
Definition potentialmanager.h:211
BoundaryConditions< 3 > bc_
Definition potentialmanager.h:209
Tensor< double > cell
Definition potentialmanager.h:210
double smoothing_param
Definition potentialmanager.h:208
A tensor is a multidimensional array.
Definition tensor.h:317
evaluates Wigner-Seitz-truncated potential in the simulation cell, due to periodic or nonperiodic sou...
Definition potentialmanager.h:149
const BoundaryConditions< 3 > bc
Definition potentialmanager.h:197
WignerSeitzPotentialFunctor(const Molecule &atoms, Tensor< double > c, BoundaryConditions< 3 > b, std::array< KernelRange, 3 > r)
same as the standard ctor, but lacks the ability to override the lattice sum range
Definition potentialmanager.h:177
const std::array< double, 3 > rcell_width
Definition potentialmanager.h:200
const std::array< double, 3 > cell_width
Definition potentialmanager.h:199
const std::array< std::int64_t, 3 > lattice_sum_range
Definition potentialmanager.h:201
WignerSeitzPotentialFunctor(const Molecule &atoms, Tensor< double > c, BoundaryConditions< 3 > b, std::array< KernelRange, 3 > r, std::array< Int, 3 > lattice_sum_range)
Definition potentialmanager.h:164
const std::array< KernelRange, 3 > range
Definition potentialmanager.h:198
const Tensor< double > cell
Definition potentialmanager.h:196
const Molecule & atoms
Definition potentialmanager.h:195
void fence(bool debug=false)
Synchronizes all processes in communicator AND globally ensures no pending AM or tasks.
Definition worldgop.cc:161
A parallel world class.
Definition world.h:132
ProcessID rank() const
Returns the process rank in this World (same as MPI_Comm_rank()).
Definition world.h:320
WorldGopInterface & gop
Global operations.
Definition world.h:207
Declaration of core potential related class.
std::complex< double > inner(const Fcwf &psi, const Fcwf &phi)
Definition fcwf.cc:275
double psi(const Vector< double, 3 > &r)
Definition hatom_energy.cc:78
double func(double x)
A simple program for testing the CubicInterpolationTable class.
Definition interp3.cc:43
Provides 1D cubic interpolation class.
#define final(a, b, c)
Definition lookup3.c:153
#define MADNESS_ASSERT(condition)
Assert a condition that should be free of side-effects since in release builds this might be a no-op.
Definition madness_exception.h:134
void print(const tensorT &t)
Definition mcpfit.cc:140
Header to declare stuff which has not yet found a home.
Main include file for MADNESS and defines Function interface.
Namespace for all elements and tools of MADNESS.
Definition DFParameters.h:10
std::shared_ptr< FunctionFunctorInterface< double, 3 > > real_functor_3d
Definition functypedefs.h:122
std::vector< real_function_3d > vector_real_function_3d
Definition functypedefs.h:94
int Level
Definition key.h:58
FunctionFactory< double, 3 > real_factory_3d
Definition functypedefs.h:108
void gaxpy(const double a, ScalarResult< T > &left, const double b, const T &right, const bool fence=true)
the result type of a macrotask must implement gaxpy
Definition macrotaskq.h:245
static const double b
Definition nonlinschro.cc:119
static const double d
Definition nonlinschro.cc:121
static const double c
Definition relops.cc:10
static const double m
Definition relops.cc:9
Defines and implements most of Tensor.
std::size_t axis
Definition testpdiff.cc:59
static Molecule molecule
Definition testperiodicdft.cc:39
real_function_1d vnuc(World &world, double t)
Definition testspectralprop.cc:347