MADNESS 0.10.1
exchangeoperator.h
Go to the documentation of this file.
1#ifndef SRC_APPS_CHEM_EXCHANGEOPERATOR_H_
2#define SRC_APPS_CHEM_EXCHANGEOPERATOR_H_
3
4#include<madness.h>
8
9namespace madness {
10
11// forward declaration
12class SCF;
13class Nemo;
14
15
16template<typename T, std::size_t NDIM>
19 typedef std::vector<functionT> vecfuncT;
20
21 static inline std::atomic<long> apply_timer;
22 static inline std::atomic<long> mul2_timer;
23 static inline std::atomic<long> mul1_timer; ///< timing
24
25 static void reset_timer() {
26 mul1_timer = 0l;
27 mul2_timer = 0l;
28 apply_timer = 0l;
29 }
30
31 static void print_timer(World& world) {
32 double t1 = double(mul1_timer) * 0.001;
33 double t2 = double(apply_timer) * 0.001;
34 double t3 = double(mul2_timer) * 0.001;
35 world.gop.sum(t1);
36 world.gop.sum(t2);
37 world.gop.sum(t3);
38 if (world.rank() == 0) {
39 printf(" cpu time spent in multiply1 %8.2fs\n", t1);
40 printf(" cpu time spent in apply %8.2fs\n", t2);
41 printf(" cpu time spent in multiply2 %8.2fs\n", t3);
42 }
43 }
44
45public:
46
49
50 /// default ctor
51 ExchangeImpl(World& world, const double lo, const double thresh) : world(world), lo(lo), thresh(thresh) {}
52
53 /// ctor with a conventional calculation
54 ExchangeImpl(World& world, const SCF *calc, const int ispin) ;
55
56 /// ctor with a nemo calculation
57 ExchangeImpl(World& world, const Nemo *nemo, const int ispin);
58
59 /// set the bra and ket orbital spaces, and the occupation
60
61 /// @param[in] bra bra space, must be provided as complex conjugate
62 /// @param[in] ket ket space
63 void set_bra_and_ket(const vecfuncT& bra, const vecfuncT& ket) {
64 mo_bra = copy(world, bra);
65 mo_ket = copy(world, ket);
66 }
67
68 std::string info() const {return "K";}
69
70 static auto set_poisson(World& world, const double lo, const double econv = FunctionDefaults<3>::get_thresh()) {
71 return std::shared_ptr<real_convolution_3d>(CoulombOperatorPtr(world, lo, econv));
72 }
73
74 /// apply the exchange operator on a vector of functions
75
76 /// note that only one spin is used (either alpha or beta orbitals)
77 /// @param[in] vket the orbitals |i> that the operator is applied on
78 /// @return a vector of orbitals K| i>
79 vecfuncT operator()(const vecfuncT& vket) const;
80
81 bool is_symmetric() const { return symmetric_; }
82
83 ExchangeImpl& set_taskq(std::shared_ptr<MacroTaskQ> taskq1) {
84 this->taskq=taskq1;
85 return *this;
86 }
87
88 ExchangeImpl& symmetric(const bool flag) {
89 symmetric_ = flag;
90 return *this;
91 }
92
94 algorithm_ = alg;
95 return *this;
96 }
97
98 ExchangeImpl& set_printlevel(const long& level) {
99 printlevel=level;
100 return *this;
101 }
102
103private:
104
105 /// exchange using macrotasks, i.e. apply K on a function in individual worlds
106 vecfuncT K_macrotask_efficient(const vecfuncT& vket, const double mul_tol = 0.0) const;
107
108 /// exchange using macrotasks, i.e. apply K on a function in individual worlds row-wise
109 vecfuncT K_macrotask_efficient_row(const vecfuncT& vket, const double mul_tol = 0.0) const;
110
111 /// computing the full square of the double sum (over vket and the K orbitals)
112 vecfuncT K_small_memory(const vecfuncT& vket, const double mul_tol = 0.0) const;
113
114 /// computing the upper triangle of the double sum (over vket and the K orbitals)
115 vecfuncT K_large_memory(const vecfuncT& vket, const double mul_tol = 0.0) const;
116
117 /// computing the upper triangle of the double sum (over vket and the K orbitals)
118 static vecfuncT compute_K_tile(World& world, const vecfuncT& mo_bra, const vecfuncT& mo_ket,
119 const vecfuncT& vket, std::shared_ptr<real_convolution_3d> poisson,
120 const bool symmetric, const double mul_tol = 0.0);
121
122 inline bool do_print_timings() const { return (world.rank() == 0) and (printlevel >= 3); }
123
124 inline bool printdebug() const {return printlevel >= 10; }
125
127 std::shared_ptr<MacroTaskQ> taskq;
128 bool symmetric_ = false; /// is the exchange matrix symmetric? K phi_i = \sum_k \phi_k \int \phi_k \phi_i
129 vecfuncT mo_bra, mo_ket; ///< MOs for bra and ket
130 double lo = 1.e-4;
132 long printlevel = 0;
134
136
138 double lo = 1.e-4;
139 double mul_tol = 1.e-7;
140 bool symmetric = false;
141
142 /// custom partitioning for the exchange operator in exchangeoperator.h
143
144 /// arguments are: result[i] += sum_k vket[k] \int 1/r vbra[k] f[i]
145 /// with f and vbra being batched, result and vket being passed on as a whole
147 public:
148 MacroTaskPartitionerExchange(const bool symmetric) : symmetric(symmetric) {
149 max_batch_size=30;
150 }
151
152 bool symmetric = false;
153
154 partitionT do_partitioning(const std::size_t& vsize1, const std::size_t& vsize2,
155 const std::string policy) const override {
156
157 partitionT partition1 = do_1d_partition(vsize1, policy);
158 partitionT partition2 = do_1d_partition(vsize2, policy);
159 partitionT result;
160 for (auto i = partition1.begin(); i != partition1.end(); ++i) {
161 if (symmetric) {
162 for (auto j = i; j != partition1.end(); ++j) {
163 Batch batch(i->first.input[0], j->first.input[0], _);
164 double priority=compute_priority(batch);
165 result.push_back(std::make_pair(batch,priority));
166 }
167 } else {
168 for (auto j = partition2.begin(); j != partition2.end(); ++j) {
169 Batch batch(i->first.input[0], j->first.input[0], _);
170 double priority=compute_priority(batch);
171 result.push_back(std::make_pair(batch,priority));
172 }
173 }
174 }
175 return result;
176 }
177
178 /// compute the priority of this task for non-dumb scheduling
179
180 /// \return the priority as double number (no limits)
181 double compute_priority(const Batch& batch) const override {
182 MADNESS_CHECK(batch.input.size() == 2); // must be quadratic batches
183 long nrow = batch.input[0].size();
184 long ncol = batch.input[1].size();
185 return double(nrow * ncol);
186 }
187 };
188
189 public:
190 MacroTaskExchangeSimple(const long nresult, const double lo, const double mul_tol, const bool symmetric)
191 : nresult(nresult), lo(lo), mul_tol(mul_tol), symmetric(symmetric) {
192 partitioner.reset(new MacroTaskPartitionerExchange(symmetric));
193 }
194
195
196 // you need to define the exact argument(s) of operator() as tuple
197 typedef std::tuple<const std::vector<Function<T, NDIM>>&,
198 const std::vector<Function<T, NDIM>>&,
199 const std::vector<Function<T, NDIM>>&> argtupleT;
200
201 using resultT = std::vector<Function<T, NDIM>>;
202
203 // you need to define an empty constructor for the result
204 // resultT must implement operator+=(const resultT&)
205 resultT allocator(World& world, const argtupleT& argtuple) const {
206 std::size_t n = std::get<0>(argtuple).size();
207 resultT result = zero_functions_compressed<T, NDIM>(world, n);
208 return result;
209 }
210
211 std::vector<Function<T, NDIM>>
212 operator()(const std::vector<Function<T, NDIM>>& vf_batch, // will be batched (column)
213 const std::vector<Function<T, NDIM>>& bra_batch, // will be batched (row)
214 const std::vector<Function<T, NDIM>>& vket) { // will not be batched
215
216 World& world = vf_batch.front().world();
217 resultT Kf = zero_functions_compressed<T, NDIM>(world, nresult);
218
219 bool diagonal_block = batch.input[0] == batch.input[1];
220 auto& bra_range = batch.input[1]; // corresponds to vbra
221 auto& vf_range = batch.input[0]; // corresponds to vf_batch
222
223 if (vf_range.is_full_size()) vf_range.end = vf_batch.size();
224 if (bra_range.is_full_size()) bra_range.end = bra_batch.size();
225
226 MADNESS_CHECK(vf_range.end <= nresult);
227 if (symmetric) MADNESS_CHECK(bra_range.end <= nresult);
228
229 if (symmetric and diagonal_block) {
230 auto ket_batch = bra_range.copy_batch(vket);
231 vecfuncT resultcolumn = compute_diagonal_batch_in_symmetric_matrix(world, ket_batch, bra_batch,
232 vf_batch);
233
234 for (int i = vf_range.begin; i < vf_range.end; ++i){
235 Kf[i] += resultcolumn[i - vf_range.begin];}
236
237 } else if (symmetric and not diagonal_block) {
238 auto[resultcolumn, resultrow]=compute_offdiagonal_batch_in_symmetric_matrix(world, vket, bra_batch,
239 vf_batch);
240
241 for (int i = bra_range.begin; i < bra_range.end; ++i){
242 Kf[i] += resultcolumn[i - bra_range.begin];}
243 for (int i = vf_range.begin; i < vf_range.end; ++i){
244 Kf[i] += resultrow[i - vf_range.begin];}
245 } else {
246 auto ket_batch = bra_range.copy_batch(vket);
247 vecfuncT resultcolumn = compute_batch_in_asymmetric_matrix(world, ket_batch, bra_batch, vf_batch);
248 for (int i = vf_range.begin; i < vf_range.end; ++i)
249 Kf[i] += resultcolumn[i - vf_range.begin];
250 }
251 return Kf;
252 }
253
254 /// compute a batch of the exchange matrix, with identical ranges, exploiting the matrix symmetry
255
256 /// \param subworld the world we're computing in
257 /// \param cloud where to store the results
258 /// \param bra_batch the bra batch of orbitals (including the nuclear correlation factor square)
259 /// \param ket_batch the ket batch of orbitals, i.e. the orbitals to premultiply with
260 /// \param vf_batch the argument of the exchange operator
262 const vecfuncT& ket_batch, // is batched
263 const vecfuncT& bra_batch, // is batched
264 const vecfuncT& vf_batch // is batched
265 ) const {
266 double mul_tol = 0.0;
267 double symmetric = true;
268 auto poisson = Exchange<double, 3>::ExchangeImpl::set_poisson(subworld, lo);
269 return Exchange<T, NDIM>::ExchangeImpl::compute_K_tile(subworld, bra_batch, ket_batch, vf_batch, poisson, symmetric,
270 mul_tol);
271 }
272
273 /// compute a batch of the exchange matrix, with non-identical ranges
274
275 /// \param subworld the world we're computing in
276 /// \param cloud where to store the results
277 /// \param bra_batch the bra batch of orbitals (including the nuclear correlation factor square)
278 /// \param ket_batch the ket batch of orbitals, i.e. the orbitals to premultiply with
279 /// \param vf_batch the argument of the exchange operator
281 const vecfuncT& ket_batch,
282 const vecfuncT& bra_batch,
283 const vecfuncT& vf_batch) const {
284 double mul_tol = 0.0;
285 double symmetric = false;
286 auto poisson = Exchange<double, 3>::ExchangeImpl::set_poisson(subworld, lo);
287 return Exchange<T, NDIM>::ExchangeImpl::compute_K_tile(subworld, bra_batch, ket_batch, vf_batch, poisson, symmetric,
288 mul_tol);
289 }
290
291 /// compute a batch of the exchange matrix, with non-identical ranges
292
293 /// \param subworld the world we're computing in
294 /// \param cloud where to store the results
295 /// \param bra_batch the bra batch of orbitals (including the nuclear correlation factor square)
296 /// \param ket_batch the ket batch of orbitals, i.e. the orbitals to premultiply with
297 /// \param vf_batch the argument of the exchange operator
298 std::pair<vecfuncT, vecfuncT> compute_offdiagonal_batch_in_symmetric_matrix(World& subworld,
299 const vecfuncT& ket, // not batched
300 const vecfuncT& bra_batch, // batched
301 const vecfuncT& vf_batch) const; // batched
302
303 };
304
306
308 double lo = 1.e-4;
309 double mul_tol = 1.e-7;
310 bool symmetric = false;
311
312 /// custom partitioning for the exchange operator in exchangeoperator.h
314 public:
316 max_batch_size=1;
317 }
318 };
319
320 public:
321 MacroTaskExchangeRow(const long nresult, const double lo, const double mul_tol)
322 : nresult(nresult), lo(lo), mul_tol(mul_tol) {
323 partitioner.reset(new MacroTaskPartitionerRow());
324 }
325
326 // you need to define the exact argument(s) of operator() as tuple
327 typedef std::tuple<const std::vector<Function<T, NDIM>>&,
328 const std::vector<Function<T, NDIM>>&,
329 const std::vector<Function<T, NDIM>>&> argtupleT;
330
331 using resultT = std::vector<Function<T, NDIM>>;
332
333 // you need to define an empty constructor for the result
334 // resultT must implement operator+=(const resultT&)
335 resultT allocator(World& world, const argtupleT& argtuple) const {
336 std::size_t n = std::get<0>(argtuple).size();
337 resultT result = zero_functions_compressed<T, NDIM>(world, n);
338 return result;
339 }
340
341 /// compute exchange row-wise for a fixed orbital phi_i of vket
342 std::vector<Function<T, NDIM>>
343 operator()(const std::vector<Function<T, NDIM>>& vket,
344 const std::vector<Function<T, NDIM>>& mo_bra,
345 const std::vector<Function<T, NDIM>>& mo_ket) {
346
347 World& world = vket.front().world();
348 mul_tol = 0.0;
349
350 resultT Kf = zero_functions_compressed<T, NDIM>(world, 1);
351 vecfuncT psif = zero_functions_compressed<T,NDIM>(world, mo_bra.size());
353
354 auto& i = batch.input[0].begin;
355 size_t min_tile = 10;
356 size_t ntile = std::min(mo_bra.size(), min_tile);
357
358 for (size_t ilo=0; ilo<mo_bra.size(); ilo+=ntile){
359 size_t iend = std::min(ilo+ntile,mo_bra.size());
360
361 vecfuncT tmp_mo_bra(mo_bra.begin()+ilo,mo_bra.begin()+iend);
362 auto tmp_psif = mul_sparse(world, vket[i], tmp_mo_bra, mul_tol);
363 truncate(world, tmp_psif);
364
365 tmp_psif = apply(world, *poisson.get(), tmp_psif);
366 truncate(world, tmp_psif);
367
368 vecfuncT tmp_mo_ket(mo_ket.begin()+ilo,mo_ket.begin()+iend);
369 auto tmp_Kf = dot(world, tmp_mo_ket, tmp_psif);
370
371 Kf[0] += tmp_Kf;
372 truncate(world, Kf);
373 }
374
375 return Kf;
376 }
377 };
378};
379
380} /* namespace madness */
381
382#endif /* SRC_APPS_CHEM_EXCHANGEOPERATOR_H_ */
Operators for the molecular HF and DFT code.
a batch consists of a 2D-input batch and a 1D-output batch: K-batch <- (I-batch, J-batch)
Definition macrotaskpartitioner.h:124
std::vector< Batch_1D > input
Definition macrotaskpartitioner.h:127
custom partitioning for the exchange operator in exchangeoperator.h
Definition exchangeoperator.h:313
resultT allocator(World &world, const argtupleT &argtuple) const
Definition exchangeoperator.h:335
std::vector< Function< T, NDIM > > operator()(const std::vector< Function< T, NDIM > > &vket, const std::vector< Function< T, NDIM > > &mo_bra, const std::vector< Function< T, NDIM > > &mo_ket)
compute exchange row-wise for a fixed orbital phi_i of vket
Definition exchangeoperator.h:343
MacroTaskExchangeRow(const long nresult, const double lo, const double mul_tol)
Definition exchangeoperator.h:321
long nresult
Definition exchangeoperator.h:307
std::tuple< const std::vector< Function< T, NDIM > > &, const std::vector< Function< T, NDIM > > &, const std::vector< Function< T, NDIM > > & > argtupleT
Definition exchangeoperator.h:329
std::vector< Function< T, NDIM > > resultT
Definition exchangeoperator.h:331
custom partitioning for the exchange operator in exchangeoperator.h
Definition exchangeoperator.h:146
double compute_priority(const Batch &batch) const override
compute the priority of this task for non-dumb scheduling
Definition exchangeoperator.h:181
MacroTaskPartitionerExchange(const bool symmetric)
Definition exchangeoperator.h:148
partitionT do_partitioning(const std::size_t &vsize1, const std::size_t &vsize2, const std::string policy) const override
override this if you want your own partitioning
Definition exchangeoperator.h:154
vecfuncT compute_diagonal_batch_in_symmetric_matrix(World &subworld, const vecfuncT &ket_batch, const vecfuncT &bra_batch, const vecfuncT &vf_batch) const
compute a batch of the exchange matrix, with identical ranges, exploiting the matrix symmetry
Definition exchangeoperator.h:261
MacroTaskExchangeSimple(const long nresult, const double lo, const double mul_tol, const bool symmetric)
Definition exchangeoperator.h:190
long nresult
Definition exchangeoperator.h:137
std::vector< Function< T, NDIM > > resultT
Definition exchangeoperator.h:201
vecfuncT compute_batch_in_asymmetric_matrix(World &subworld, const vecfuncT &ket_batch, const vecfuncT &bra_batch, const vecfuncT &vf_batch) const
compute a batch of the exchange matrix, with non-identical ranges
Definition exchangeoperator.h:280
std::vector< Function< T, NDIM > > operator()(const std::vector< Function< T, NDIM > > &vf_batch, const std::vector< Function< T, NDIM > > &bra_batch, const std::vector< Function< T, NDIM > > &vket)
Definition exchangeoperator.h:212
std::tuple< const std::vector< Function< T, NDIM > > &, const std::vector< Function< T, NDIM > > &, const std::vector< Function< T, NDIM > > & > argtupleT
Definition exchangeoperator.h:199
resultT allocator(World &world, const argtupleT &argtuple) const
Definition exchangeoperator.h:205
Definition exchangeoperator.h:17
static std::atomic< long > mul1_timer
timing
Definition exchangeoperator.h:23
ExchangeImpl & symmetric(const bool flag)
Definition exchangeoperator.h:88
static void print_timer(World &world)
Definition exchangeoperator.h:31
ExchangeImpl & set_printlevel(const long &level)
Definition exchangeoperator.h:98
Exchange< T, NDIM >::Algorithm Algorithm
Definition exchangeoperator.h:47
static void reset_timer()
Definition exchangeoperator.h:25
vecfuncT mo_bra
is the exchange matrix symmetric? K phi_i = \sum_k \phi_k \int \phi_k \phi_i
Definition exchangeoperator.h:129
World & world
Definition exchangeoperator.h:126
std::shared_ptr< MacroTaskQ > taskq
Definition exchangeoperator.h:127
Function< T, NDIM > functionT
Definition exchangeoperator.h:18
bool is_symmetric() const
Definition exchangeoperator.h:81
ExchangeImpl & set_taskq(std::shared_ptr< MacroTaskQ > taskq1)
Definition exchangeoperator.h:83
std::vector< functionT > vecfuncT
Definition exchangeoperator.h:19
ExchangeImpl & set_algorithm(const Algorithm &alg)
Definition exchangeoperator.h:93
static std::atomic< long > apply_timer
Definition exchangeoperator.h:21
ExchangeImpl(World &world, const double lo, const double thresh)
default ctor
Definition exchangeoperator.h:51
std::string info() const
Definition exchangeoperator.h:68
bool do_print_timings() const
Definition exchangeoperator.h:122
bool printdebug() const
Definition exchangeoperator.h:124
static auto set_poisson(World &world, const double lo, const double econv=FunctionDefaults< 3 >::get_thresh())
Definition exchangeoperator.h:70
static std::atomic< long > mul2_timer
Definition exchangeoperator.h:22
void set_bra_and_ket(const vecfuncT &bra, const vecfuncT &ket)
set the bra and ket orbital spaces, and the occupation
Definition exchangeoperator.h:63
Definition SCFOperators.h:104
Algorithm
Definition SCFOperators.h:116
@ multiworld_efficient_row
Definition SCFOperators.h:117
Function< T, NDIM > operator()(const Function< T, NDIM > &ket) const
Definition SCFOperators.h:150
std::vector< functionT > vecfuncT
Definition SCFOperators.h:110
FunctionDefaults holds default paramaters as static class members.
Definition funcdefaults.h:100
static const double & get_thresh()
Returns the default threshold.
Definition funcdefaults.h:176
A multiresolution adaptive numerical function.
Definition mra.h:139
Definition macrotaskq.h:978
partition one (two) vectors into 1D (2D) batches.
Definition macrotaskpartitioner.h:182
std::list< std::pair< Batch, double > > partitionT
Definition macrotaskpartitioner.h:186
The Nemo class.
Definition nemo.h:326
std::shared_ptr< MacroTaskQ > taskq
Definition SCFOperators.h:70
Definition SCF.h:187
void sum(T *buf, size_t nelem)
Inplace global sum while still processing AM & tasks.
Definition worldgop.h:870
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
ProcessID size() const
Returns the number of processes in this World (same as MPI_Comm_size()).
Definition world.h:330
WorldGopInterface & gop
Global operations.
Definition world.h:207
Declares the Cloud class for storing data and transfering them between worlds.
static double lo
Definition dirac-hatom.cc:23
std::vector< Spinor > truncate(std::vector< Spinor > arg)
Definition dirac-hatom.cc:499
Fcwf apply(World &world, real_convolution_3d &op, const Fcwf &psi)
Definition fcwf.cc:281
auto T(World &world, response_space &f) -> response_space
Definition global_functions.cc:34
Declares the macrotaskq and MacroTaskBase classes.
General header file for using MADNESS.
#define MADNESS_CHECK(condition)
Check a condition — even in a release build the condition is always evaluated so it can have side eff...
Definition madness_exception.h:182
Namespace for all elements and tools of MADNESS.
Definition DFParameters.h:10
static SeparatedConvolution< double, 3 > * CoulombOperatorPtr(World &world, double lo, double eps, const array_of_bools< 3 > &lattice_sum=FunctionDefaults< 3 >::get_bc().is_periodic(), int k=FunctionDefaults< 3 >::get_k())
Factory function generating separated kernel for convolution with 1/r in 3D.
Definition operator.h:1818
Function< TENSOR_RESULT_TYPE(L, R), NDIM > mul_sparse(const Function< L, NDIM > &left, const Function< R, NDIM > &right, double tol, bool fence=true)
Sparse multiplication — left and right must be reconstructed and if tol!=0 have tree of norms already...
Definition mra.h:1806
Function< TENSOR_RESULT_TYPE(T, R), NDIM > dot(World &world, const std::vector< Function< T, NDIM > > &a, const std::vector< Function< R, NDIM > > &b, bool fence=true)
Multiplies and sums two vectors of functions r = \sum_i a[i] * b[i].
Definition vmra.h:1565
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 thresh
Definition rk.cc:45
constexpr std::size_t NDIM
Definition testgconv.cc:54