MADNESS 0.10.1
electronic_correlation_factor.h
Go to the documentation of this file.
1/*
2 * electronic_correlation_factor.h
3 *
4 * Created on: Jul 9, 2015
5 * Author: fbischoff
6 */
7
8#ifndef SRC_APPS_CHEM_ELECTRONIC_CORRELATION_FACTOR_H_
9#define SRC_APPS_CHEM_ELECTRONIC_CORRELATION_FACTOR_H_
10
11
12
13#include <madness/mra/mra.h>
14#include <madness/mra/lbdeux.h>
16#include <iomanip>
17
18namespace madness {
19/// a class holding the electronic correlation factor for R12 theory
20class CorrelationFactor {
21
22 World& world;
23 double _gamma; ///< the correlation factor exp(-gamma r12)
24 double dcut; ///< the cutoff for the 1/r potential
25 double lo; ///< smallest length scale to be resolved
26
27public:
28
29 /// ctor, use negative gamma for linear correlation factor r12
30 CorrelationFactor(World& world) : world(world), _gamma(-1.0), dcut(1.e-10),
31 lo(1.e-10) {
32 }
33
34 /// ctor, use negative gamma for linear correlation factor r12
35 CorrelationFactor(World& world, const double& gamma, const double dcut,
36 const Molecule& molecule) : world(world), _gamma(gamma), dcut(dcut) {
37 lo=1.e-6;//lo = molecule.smallest_length_scale();
38// if (world.rank()==0) {
39// if (gamma>0.0) print("constructed correlation factor with gamma=",gamma);
40// else if (gamma==0.0) print("constructed linear correlation factor");
41// }
42 }
43 /// ctor, use negative gamma for linear correlation factor r12
44 CorrelationFactor(World& world, const double& gamma, const double dcut,
45 const double lo) : world(world), _gamma(gamma), dcut(dcut), lo(lo) {
46// if (world.rank()==0) {
47// if (gamma>0.0) print("constructed correlation factor with gamma=",gamma);
48// else if (gamma==0.0) print("constructed linear correlation factor");
49// }
50 }
51
52 /// copy ctor
53 CorrelationFactor(const CorrelationFactor& other) : world(other.world) {
54 _gamma=other._gamma;
55 dcut=other.dcut;
56 lo=other.lo;
57 }
58
59 /// assignment; assume other's world is this world
60 CorrelationFactor& operator=(const CorrelationFactor& other) {
61 _gamma=other._gamma;
62 dcut=other.dcut;
63 lo=other.lo;
64 return *this;
65 }
66
67 /// return the exponent of this correlation factor
68 double gamma() const {return _gamma;}
69
70 /// return the value of the correlation factor
71 double operator()(const coord_6d& r) const {
72 const double rr=r12(r);
73 if (_gamma>0.0) return (1.0-exp(-_gamma*rr))/(2.0*_gamma);
74 return 0.5*rr;
75 }
76
77 /// apply Kutzelnigg's regularized potential to an orbital product
78 real_function_6d apply_U(const real_function_3d& phi_i, const real_function_3d& phi_j,
79 const real_convolution_6d& op_mod, const bool symmetric=false) const {
80 if(not op_mod.modified()) MADNESS_EXCEPTION("ElectronicCorrelationFactor::apply_U, op_mod must be in modified_NS form",1);
81 const double thresh = FunctionDefaults<6>::get_thresh();
82 const bool debug = false;
83 if(symmetric) MADNESS_ASSERT((phi_i-phi_j).norm2() < FunctionDefaults<3>::get_thresh());
84
86
87 for (int axis=0; axis<3; ++axis) {
88 //if (world.rank()==0) print("working on axis",axis);
89 real_derivative_3d D = free_space_derivative<double,3>(world, axis);
90 const real_function_3d Di=(D(phi_i)).truncate();
92 if(symmetric) Dj=madness::copy(Di);
93 else Dj=(D(phi_j)).truncate();
94
96 real_function_6d tmp1=CompositeFactory<double,6,3>(world)
97 .g12(u).particle1(copy(Di)).particle2(copy(phi_j)).thresh(thresh);
98 tmp1.fill_cuspy_tree(op_mod).truncate();
99
100 real_function_6d tmp2;
101 if(symmetric) tmp2 = -1.0*swap_particles(tmp1);
102 else{
103 tmp2=CompositeFactory<double,6,3>(world)
104 .g12(u).particle1(copy(phi_i)).particle2(copy(Dj)).thresh(thresh);
105 tmp2.fill_cuspy_tree(op_mod).truncate();
106 }
107
108 result=result+(tmp1-tmp2).truncate();
109
110
111 tmp1.clear();
112 tmp2.clear();
113 world.gop.fence();
114 result.truncate().reduce_rank();
115 }
116
117 // include the purely local potential that (partially) cancels 1/r12
118 if (_gamma>0.0) {
119 fg_ func(_gamma,dcut);
121 real_function_6d mul=CompositeFactory<double,6,3>(world)
122 .g12(fg3).particle1(copy(phi_i)).particle2(copy(phi_j)).thresh(thresh);;
123 mul.fill_cuspy_tree(op_mod).truncate();
124 // mul.print_size("mul");
125
126 result=(result+mul).truncate().reduce_rank();
127 }
128 if(debug) result.print_size("Ue|ij>");
129 return result;
130 }
131
132 /// return the U1 term of the correlation function
133 real_function_6d U1(const int axis) const {
134 U func(_gamma,axis,dcut);
135 const real_function_6d u1=real_factory_6d(world)
137 return u1;
138 }
139
140 /// return the U1 term of the correlation function
141 real_function_6d U2() const {
142 if (world.rank()==0) print("U2 for the electronic correlation factor");
143 if (world.rank()==0) print("is expensive -- do you really need it??");
144 MADNESS_EXCEPTION("U2() not implemented, since it might be expensive",1);
145 return real_factory_6d(world);
146 }
147
148 /// return the correlation factor as on-demand function
149 real_function_6d f() const {
150// real_function_6d tmp=real_factory_6d(world).functor2(*this).is_on_demand();
151 double thresh=FunctionDefaults<3>::get_thresh();
152 real_function_6d tmp=TwoElectronFactory(world)
153 .dcut(dcut).gamma(_gamma).f12().thresh(thresh);
154 return tmp;
155 }
156
157 /// return f^2 as on-demand function
158 real_function_6d f2() const {
159 f2_ func(_gamma);
161 return tmp;
162 }
163
164 /// return fg+sth as on-demand function
165 real_function_6d fg() const {
166 fg_ func(_gamma,dcut);
168 return tmp;
169 }
170
171 /// return f/r as on-demand function
172 real_function_6d f_over_r() const {
173 f_over_r_ func(_gamma,dcut);
175 return tmp;
176 }
177
178 /// return (\nabla f)^2 as on-demand functions
179 real_function_6d nablaf2() const {
180 nablaf2_ func(_gamma);
182 return tmp;
183 }
184
185private:
186 /// functor for the local potential (1-f12)/r12 + sth (doubly connected term of the commutator)
187
188 /// TODO: turn this into coeffs directly
189 struct fg_ : FunctionFunctorInterface<double,6> {
190 double gamma;
191 double dcut;
192 fg_(double gamma, double dcut) : gamma(gamma), dcut(dcut) {
193 MADNESS_ASSERT(gamma>0.0);
194 }
195 double operator()(const coord_6d& r) const {
196 const double rr=r12(r);
197 const double e=exp(-gamma*rr);
198 if (rr<5.e-2) {
199 double value= 1.5*gamma - 1.*std::pow(gamma,2)*rr + 0.41666666666666663*std::pow(gamma,3)*std::pow(rr,2) -
200 0.125*std::pow(gamma,4)*std::pow(rr,3) + 0.029166666666666667*std::pow(gamma,5)*std::pow(rr,4)
201 + 0.005555555555555556*std::pow(gamma,6)*std::pow(rr,5) +
202 0.0008928571428571429*std::pow(gamma,7)*std::pow(rr,6);
203 return value;
204 } else {
205 // return (1.0-e)*u(rr,dcut) + 0.5*gamma*e;
206 return (1.0-e)/rr + 0.5*gamma*e;
207 }
208 }
209 };
210
211 /// functor for the local potential (1-f12)/r12
212 struct f_over_r_ : FunctionFunctorInterface<double,6> {
213 double gamma;
214 double dcut;
215 f_over_r_(double gamma, double dcut) : gamma(gamma), dcut(dcut) {
216 MADNESS_ASSERT(gamma>0.0);
217 }
218 double operator()(const coord_6d& r) const {
219 const double rr=r12(r);
220 const double e=exp(-gamma*rr);
221 return (1.0-e)*u(rr,dcut)/(2.0*gamma);
222 }
223 };
224
225 /// functor for the local part of the regularized potential: f12/r12*(r1-r2)(D1-D2)
226 struct U : FunctionFunctorInterface<double,6> {
227 double gamma;
228 int axis;
229 double dcut;
230 U(double gamma, int axis, double dcut) : gamma(gamma), axis(axis),
231 dcut(dcut) {
232 MADNESS_ASSERT(axis>=0 and axis<3);
233 }
234 double operator()(const coord_6d& r) const {
235 const double rr=r12(r);
236 const coord_3d vr12{r[0]-r[3],r[1]-r[4],r[2]-r[5]};
237 const coord_3d N=unitvec(vr12);
238 if (gamma>0.0) return -0.5*exp(-gamma*rr)*N[axis];
239 MADNESS_EXCEPTION("no gamma in electronic corrfac::U1",1);
240// const double rr=r12(r);
241// const double g12=u(rr,dcut);
242// double a=0.5;
243// if (gamma>0.0) a=0.5*exp(-gamma*rr);
244// return -a*x12(r,axis) * g12;
245 }
246 };
247
248 /// functor for the local potential (1-f12)^2
249 struct f2_ : FunctionFunctorInterface<double,6> {
250 double gamma;
251 f2_(double gamma) : gamma(gamma) {MADNESS_ASSERT(gamma>0.0);}
252 double operator()(const coord_6d& r) const {
253 const double rr=r12(r);
254 const double e=exp(-gamma*rr);
255 const double f=(1.0-e)/(2.0*gamma);
256 return f*f;
257 }
258 };
259
260 /// functor for the local potential (\nabla f)^2
261 struct nablaf2_ : FunctionFunctorInterface<double,6> {
262 double gamma;
263 nablaf2_(double gamma) : gamma(gamma) {
264 MADNESS_ASSERT(gamma>0.0);
265 MADNESS_ASSERT(gamma==1.0);
266 }
267 double operator()(const coord_6d& r) const {
268 const double rr=r12(r);
269 const double f=exp(-2.0*gamma*rr)/(4.0*gamma*gamma);
270 return f;
271 }
272 };
273
274 /// Smoothed 1/r potential (c is the smoothing distance)
275 static double u(double r, double c) {
276 r = r/c;
277 double r2 = r*r, pot;
278 if (r > 6.5){
279 pot = 1.0/r;
280 } else if (r > 1e-2) {
281 pot = erf(r)/r + exp(-r2)*0.56418958354775630;
282 } else{
283 pot = 1.6925687506432689-r2*(0.94031597257959381-r2*(0.39493270848342941-0.12089776790309064*r2));
284 }
285 return pot/c;
286 }
287
288 static double r12(const coord_6d& r) {
289 const double x12=r[0]-r[3];
290 const double y12=r[1]-r[4];
291 const double z12=r[2]-r[5];
292 const double r12=sqrt(x12*x12 + y12*y12 + z12*z12);
293 return r12;
294 }
295 static double x12(const coord_6d& r, const int axis) {
296 return r[axis]-r[axis+3];
297 }
298
299 static coord_3d smoothed_unitvec(const coord_3d& xyz, double smoothing) {
300// if (smoothing==0.0) smoothing=molecule.get_eprec();
301 // TODO:need to test this
302 // reduce the smoothing for the unitvector
303 //if (not (this->type()==None or this->type()==Two)) smoothing=sqrt(smoothing);
304 const double r=xyz.normf();
305 const double cutoff=smoothing;
306 if (r>cutoff) {
307 return 1.0/r*xyz;
308 } else {
309 const double xi=r/cutoff;
310 const double xi2=xi*xi;
311 const double xi3=xi*xi*xi;
312// const double nu21=0.5+1./32.*(45.*xi - 50.*xi3 + 21.*xi*xi*xi*xi*xi);
313 const double nu22=0.5 + 1./64.*(105* xi - 175 *xi3 + 147* xi2*xi3 - 45* xi3*xi3*xi);
314// const double nu40=0.5 + 1./128.*(225 *xi - 350 *xi3 + 189*xi2*xi3);
315 const double kk=2.*nu22-1.0;
316 return kk/(r+1.e-15)*xyz;
317 }
318 }
319};
320
321/// a class holding the electronic correlation factor for R12 theory
322/// CorrelationFactor2 = (1-0.5*exp(-gamma*r12), gamma=0.5
323/// (CorrelationFactor + 1)*2.0 = CorrelationFactor2 (currently CorrelationFactor2 is only implemented for gamma=0.5 so use this gamma also on CorrelationFactor
324class CorrelationFactor2 {
325
326 World& world;
327 double _gamma; ///< the correlation factor exp(-gamma r12)
328 typedef std::shared_ptr< FunctionFunctorInterface<double,6> > functorT;
329
330public:
331
332 double dcut; ///< the cutoff for the 1/r potential
333 double lo; ///< smallest length scale to be resolved
334 double vtol; ///< initial projection threshold
335
336
337 /// ctor, use negative gamma for linear correlation factor r12
338 CorrelationFactor2(World& world) : world(world), _gamma(0.5), dcut(1.e-10),
339 lo(1.e-10), vtol(FunctionDefaults<3>::get_thresh()*0.1) {
340 MADNESS_ASSERT(_gamma==0.5);
341 }
342
343 /// return the exponent of this correlation factor
344 double gamma() const {return _gamma;}
345
346 real_function_6d function() const {
347 functorT R=functorT(new R_functor(_gamma,1));
348 return real_factory_6d(world).functor(R).is_on_demand();
349 }
350
351 real_function_6d square() const {
352 functorT R2=functorT(new R_functor(_gamma,2));
353 return real_factory_6d(world).functor(R2).is_on_demand();
354 }
355
356 real_function_6d inverse() const {
357 functorT R=functorT(new R_functor(_gamma,-1));
358 return real_factory_6d(world).functor(R).is_on_demand();
359 }
360
361 /// return the U1 term of the correlation function
362 real_function_6d U1(const int axis) const {
363 functorT U1f=functorT(new U1_functor(_gamma,axis));
364 return real_factory_6d(world).functor(U1f).is_on_demand();
365 }
366
367 /// return the U2 term of the correlation function
368 real_function_6d U2() const {
369 functorT U2f=functorT(new U2_functor(_gamma));
370 return real_factory_6d(world).functor(U2f).is_on_demand();
371 }
372
373 /// apply Kutzelnigg's regularized potential to an orbital product
374 real_function_6d apply_U(const real_function_6d& psi, const double eps) const {
375 const double bsh_thresh=1.e-7;
376
377 real_function_6d result=real_factory_6d(world);
378
379 real_convolution_6d op_mod = BSHOperator<6>(world, sqrt(-2*eps), lo,bsh_thresh);
380 op_mod.modified()=true;
381
382 for (int axis=0; axis<3; ++axis) {
383 //if (world.rank()==0) print("working on axis",axis);
384 real_derivative_6d D1 = free_space_derivative<double,6>(world, axis);
385 real_derivative_6d D2 = free_space_derivative<double,6>(world, axis+3);
386 const real_function_6d Drhs1=D1(psi).truncate();
387 const real_function_6d Drhs2=D2(psi).truncate();
388
389 const real_function_6d u1=U1(axis);
390
391 real_function_6d tmp1=CompositeFactory<double,6,3>(world)
392 .g12(u1).ket(copy(Drhs1));
393 tmp1.fill_cuspy_tree(op_mod).truncate();
394
395 real_function_6d tmp2=CompositeFactory<double,6,3>(world)
396 .g12(u1).ket(copy(Drhs2));
397 tmp2.fill_cuspy_tree(op_mod).truncate();
398 // if (world.rank()==0) print("done with fill_tree");
399
400 result=result+(tmp1-tmp2).truncate();
401 tmp1.clear();
402 tmp2.clear();
403 world.gop.fence();
404 result.truncate().reduce_rank();
405
406 // if (world.rank()==0) printf("done with multiplication with U at ime %.1f\n",wall_time());
407 // result.print_size("result");
408 }
409
410 real_function_6d u2=U2();
411 real_function_6d r2=CompositeFactory<double,6,3>(world).ket(copy(psi))
412 .g12(u2);
413 r2.fill_tree(op_mod);
414 result=(result+r2).truncate();
415 return result;
416 }
417
418
419private:
420
421 /// functor for the correlation factor R
422 class R_functor : public FunctionFunctorInterface<double,6> {
423 double gamma;
424 int exponent;
425
426
427 public:
428 R_functor(double gamma, int e=1) : gamma(gamma), exponent(e) {
429 MADNESS_ASSERT(gamma==0.5);
430 }
431
432 // only valid for gamma=1
433 double operator()(const coord_6d& r) const {
434 const double rr=r12(r);
435 double val=(1.0-0.5*exp(-gamma*rr));
436 if (exponent==1) return val;
437 else if (exponent==2) return val*val;
438 else if (exponent==-1) return 1.0/val;
439 else {
440 MADNESS_EXCEPTION("fancy exponent in correlationfactor2",1);
441 }
442 }
443 };
444
445 /// functor for the U2 local potential
446 class U2_functor : public FunctionFunctorInterface<double,6> {
447 double gamma;
448
449 public:
450 U2_functor(double gamma) : gamma(gamma) {
451 MADNESS_ASSERT(gamma==0.5);
452 }
453
454 // only valid for gamma=1
455 double operator()(const coord_6d& r) const {
456 const double rr=r12(r);
457 // Taylor expansion for small r
458 if (rr<1.e-4) { // valid for gamma==0.5, otherwise singular
459 return (5./4.0 - rr + (35.0* rr*rr)/48.0 - (101.0*rr*rr*rr)/192.0);
460 }
461 const double egr=exp(-gamma*rr);
462 return -(-8.*egr + 8.0 + rr*egr)/(4.0 *rr*egr - 8 *rr);
463 }
464 };
465
466 /// functor for the U1 = -\frac{\vec\nabla_1 f_{12}}{f_{12}} potential
467
468 /// the potential is given by
469 /// U1 = -\frac{\vec\nabla_1 f_{12}}{f_{12}}
470 /// = \frac{e^{-r12/2}{4-2e^{-r12/2}} \vec unitvec
471 /// the derivative operators are not included
472 class U1_functor : public FunctionFunctorInterface<double,6> {
473 double gamma;
474 int axis;
475
476 public:
477 U1_functor(double gamma, int axis) : gamma(gamma), axis(axis) {
478 MADNESS_ASSERT(gamma==0.5);
480 }
481
482 double operator()(const coord_6d& r) const {
483 const double rr=r12(r);
484 const coord_3d vr12{r[0]-r[3],r[1]-r[4],r[2]-r[5]};
485 const coord_3d N=unitvec(vr12);
486 // Taylor expansion for small r
487 double val;
488 if (rr<1.e-4) { // valid for gamma==0.5, otherwise singular
489 val = 0.5 - 0.5*rr + 0.125*(3.*rr*rr) - (13.* rr*rr*rr)/48.0;
490 } else {
491 const double egr=exp(-gamma*rr);
492 val=egr/(4.0-2.0*egr);
493 }
494 // NOTE the sign
495 return -val*N[axis];
496 }
497 };
498
499 /// helper function
500 static double r12(const coord_6d& r) {
501 const double x12=r[0]-r[3];
502 const double y12=r[1]-r[4];
503 const double z12=r[2]-r[5];
504 const double r12=sqrt(x12*x12 + y12*y12 + z12*z12);
505 return r12;
506 }
507
508};
509
510}
511
512
513
514#endif /* SRC_APPS_CHEM_ELECTRONIC_CORRELATION_FACTOR_H_ */
FunctionFactory & functor(const std::shared_ptr< FunctionFunctorInterface< T, NDIM > > &f)
Definition function_factory.h:141
virtual FunctionFactory & is_on_demand()
Definition function_factory.h:288
Function< T, NDIM > & fill_tree(const Function< R, NDIM > &g, bool fence=true)
With this being an on-demand function, fill the MRA tree according to different criteria.
Definition mra.h:1192
Function< T, NDIM > & fill_cuspy_tree(const opT &op, const bool fence=true)
Definition mra.h:1233
double thresh() const
Returns value of truncation threshold. No communication.
Definition mra.h:607
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
constexpr T normf() const
Calculate the 2-norm of the vector elements.
Definition vector.h:421
static const double R
Definition csqrt.cc:46
double(* f)(const coord_3d &)
Definition derivatives.cc:54
double(* f2)(const coord_3d &)
Definition derivatives.cc:56
static double lo
Definition dirac-hatom.cc:23
static bool debug
Definition dirac-hatom.cc:16
std::vector< Spinor > truncate(std::vector< Spinor > arg)
Definition dirac-hatom.cc:499
Fcwf copy(Fcwf psi)
Definition fcwf.cc:338
static double function(const coord_3d &r)
Normalized gaussian.
Definition functionio.cc:100
double square(double x)
Definition gfit.cc:59
double psi(const Vector< double, 3 > &r)
Definition hatom_energy.cc:78
static double u(double r, double c)
Definition he.cc:20
static const double dcut
Definition he.cc:13
double func(double x)
A simple program for testing the CubicInterpolationTable class.
Definition interp3.cc:43
Implements (2nd generation) static load/data balancing for functions.
#define MADNESS_EXCEPTION(msg, value)
Macro for throwing a MADNESS exception.
Definition madness_exception.h:119
#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
std::shared_ptr< FunctionFunctorInterface< double, 3 > > functorT
Definition mcpfit.cc:49
void print(const tensorT &t)
Definition mcpfit.cc:140
Main include file for MADNESS and defines Function interface.
Namespace for all elements and tools of MADNESS.
Definition DFParameters.h:10
Function< TENSOR_RESULT_TYPE(Q, T), NDIM > mul(const Q alpha, const Function< T, NDIM > &f, bool fence=true)
Returns new function equal to alpha*f(x) with optional fence.
Definition mra.h:1765
std::enable_if_t< NDIM%2==0, Function< T, NDIM > > swap_particles(const Function< T, NDIM > &f)
swap particles 1 and 2
Definition mra.h:2367
double norm2(World &world, const std::vector< Function< T, NDIM > > &v)
Computes the 2-norm of a vector of functions.
Definition vmra.h:871
Tensor< T > inverse(const Tensor< T > &a_in)
invert general square matrix A
Definition lapack.cc:832
constexpr Vector< T, N > unitvec(const Vector< T, N > &r, const double eps=1.e-6)
Construct a unit-Vector that has the same direction as r.
Definition vector.h:768
Function< double, 6 > real_function_6d
Definition functypedefs.h:83
Function< double, 3 > real_function_3d
Definition functypedefs.h:80
SeparatedConvolution< double, 6 > real_convolution_6d
Definition functypedefs.h:139
Vector< double, 3 > coord_3d
Definition funcplot.h:1043
Derivative< double, 6 > real_derivative_6d
Definition functypedefs.h:188
FunctionFactory< double, 6 > real_factory_6d
Definition functypedefs.h:111
Derivative< double, 3 > real_derivative_3d
Definition functypedefs.h:185
Function< T, NDIM > copy(const Function< T, NDIM > &f, const std::shared_ptr< WorldDCPmapInterface< Key< NDIM > > > &pmap, bool fence=true)
Create a new copy of the function with different distribution and optional fence.
Definition mra.h:2066
static const double c
Definition relops.cc:10
static const double thresh
Definition rk.cc:45
const double xi
Exponent for delta function approx.
Definition siam_example.cc:60
Definition test_ar.cc:204
void e()
Definition test_sig.cc:75
#define N
Definition testconv.cc:37
std::size_t axis
Definition testpdiff.cc:59
static Molecule molecule
Definition testperiodicdft.cc:39
const double R2
Definition vnucso.cc:84