32#ifndef MADNESS_MRA_OPERATOR_H__INCLUDED
33#define MADNESS_MRA_OPERATOR_H__INCLUDED
56 template<
typename T, std::
size_t NDIM>
59 template<
typename T, std::
size_t NDIM>
60 class SeparatedConvolution;
62 template<
typename T, std::
size_t NDIM>
65 template <
typename T,
typename R, std::
size_t NDIM, std::
size_t KDIM>
67 apply(
const SeparatedConvolution<T,KDIM>&
op,
const std::vector< Function<R,NDIM> >
f);
69 template<
typename T, std::
size_t NDIM>
70 std::vector<CCPairFunction<T,NDIM>>
apply(
const SeparatedConvolution<T,NDIM>&
op,
const std::vector<CCPairFunction<T,NDIM>>& argument);
72 template<
typename T, std::
size_t NDIM>
73 std::vector<CCPairFunction<T,NDIM>>
apply(
const SeparatedConvolution<T,NDIM/2>&
op,
const std::vector<CCPairFunction<T,NDIM>>& argument);
75 template<
typename T, std::
size_t NDIM>
76 CCPairFunction<T,NDIM>
apply(
const SeparatedConvolution<T,NDIM>&
op,
const CCPairFunction<T,NDIM>& argument);
78 template<
typename T, std::
size_t NDIM>
79 CCPairFunction<T,NDIM>
apply(
const SeparatedConvolution<T,NDIM/2>&
op,
const CCPairFunction<T,NDIM>& argument);
83 template <
typename Q, std::
size_t NDIM>
92 template <
typename Q, std::
size_t NDIM>
94 std::vector< SeparatedConvolutionInternal<Q,NDIM> >
muops;
138 template <
typename Q, std::
size_t NDIM>
154 std::array<KernelRange, NDIM>
range;
172 mutable std::vector< ConvolutionND<Q,NDIM> >
ops;
176 const std::vector<long>
vk;
177 const std::vector<long>
v2k;
178 const std::vector<Slice>
s0;
192 if (
p!=1 and
p!=2)
throw std::runtime_error(
"particle must be 1 or 2");
204 const std::vector<ConvolutionND<Q,NDIM>>&
get_ops()
const {
return ops; }
227 const std::array<LatticeRange, NDIM>& lattice_ranges) {
231 double hi = cell_width.
normf();
234 bool lattice_summed_any = std::any_of(
235 lattice_ranges.begin(), lattice_ranges.end(), [](
const LatticeRange&
b){ return static_cast<bool>(b); });
236 bool infinite_summed_any =
false;
237 for (
size_t i = 0; i <
NDIM; i++) {
238 if (lattice_ranges[i].infinite() &&
info.
range[i].infinite()) {
239 infinite_summed_any =
true;
256 double max_lattice_spacing = 0;
258 if (lattice_ranges[
d])
259 max_lattice_spacing =
260 std::max(max_lattice_spacing, cell_width(
d));
264 fit.truncate_periodic_expansion(coeff, expnt, max_lattice_spacing,
269 return std::make_pair(coeff, expnt);
306 template <
typename T,
typename R>
317 for (std::size_t i=0; i<
NDIM; ++i) size *= dimk;
318 long dimi = size/dimk;
320 R* MADNESS_RESTRICT w1=work1.
ptr();
321 R* MADNESS_RESTRICT w2=work2.
ptr();
324 mTxmq_padding(dimi, trans[0].r, dimk, dimk, w1,
f.ptr(), trans[0].U);
326 mTxmq(dimi, trans[0].r, dimk, w1,
f.ptr(), trans[0].U, dimk);
329 size = trans[0].r * size / dimk;
331 for (std::size_t
d=1;
d<
NDIM; ++
d) {
335 mTxmq(dimi, trans[
d].r, dimk, w2, w1, trans[
d].U, dimk);
337 size = trans[
d].r * size / dimk;
347 for (std::size_t
d=0;
d<
NDIM; ++
d) {
349 dimi = size/trans[
d].r;
353 mTxmq(dimi, dimk, trans[
d].r, w2, w1, trans[
d].VT);
355 size = dimk*size/trans[
d].r;
369 template <
typename T,
typename R>
378 result2.
scale(mufac);
386 template <
typename T,
typename R>
404 for (std::size_t i=0; i<
NDIM; ++i) size *= dimk;
405 long dimi = size/dimk;
407 R* MADNESS_RESTRICT w1=work1.
ptr();
408 R* MADNESS_RESTRICT w2=work2.
ptr();
410 mTxmq(dimi, trans[0].r, dimk, w1,
f.ptr(), trans[0].U, dimk);
411 size = trans[0].r * size / dimk;
413 for (std::size_t
d=1;
d<
NDIM; ++
d) {
414 mTxmq(dimi, trans[
d].r, dimk, w2, w1, trans[
d].U, dimk);
415 size = trans[
d].r * size / dimk;
425 for (std::size_t
d=0;
d<
NDIM; ++
d) {
427 dimi = size/trans[
d].r;
428 mTxmq(dimi, dimk, trans[
d].r, w2, w1, trans[
d].VT);
429 size = dimk*size/trans[
d].r;
446 template <
typename T>
462 for (std::size_t
d=0;
d<
NDIM; ++
d) Rnorm *= ops_1d[
d]->Rnorm;
464 if (at.
r_term and (Rnorm > 1.e-20)) {
466 const auto tol_Rs = tol/(Rnorm*
NDIM);
473 if (
NDIM==1) break_even = long(0.5*twok);
474 else if (
NDIM==2) break_even = long(0.6*twok);
475 else if (
NDIM==3) break_even=long(0.65*twok);
476 else break_even=long(0.7*twok);
477 bool rank_is_zero =
false;
478 for (std::size_t
d=0;
d<
NDIM; ++
d) {
480 for (r=0; r<twok; ++r) {
481 if (ops_1d[
d]->Rs[r] < tol_Rs)
break;
483 if (r >= break_even) {
485 trans[
d].
U = ops_1d[
d]->R.ptr();
491 r = std::max(2L,r+(r&1L));
498 trans[
d].
U = ops_1d[
d]->RU.ptr();
499 trans[
d].
VT = ops_1d[
d]->RVT.ptr();
501 trans2[
d]=ops_1d[
d]->R;
512 for (std::size_t
d=0;
d<
NDIM; ++
d) Tnorm *= ops_1d[
d]->Tnorm;
514 if (at.
t_term and (Tnorm>0.0)) {
515 const auto tol_Ts = tol/(Tnorm*
NDIM);
518 if (
NDIM==1) break_even = long(0.5*
k);
519 else if (
NDIM==2) break_even = long(0.6*
k);
520 else if (
NDIM==3) break_even=long(0.65*
k);
521 else break_even=long(0.7*
k);
522 bool rank_is_zero =
false;
523 for (std::size_t
d=0;
d<
NDIM; ++
d) {
525 for (r=0; r<
k; ++r) {
526 if (ops_1d[
d]->Ts[r] < tol_Ts)
break;
528 if (r >= break_even) {
530 trans[
d].
U = ops_1d[
d]->T.ptr();
536 r = std::max(2L,r+(r&1L));
543 trans[
d].
U = ops_1d[
d]->TU.ptr();
544 trans[
d].
VT = ops_1d[
d]->TVT.ptr();
546 trans2[
d]=ops_1d[
d]->T;
557 template <
typename T>
574 for (std::size_t
d=0;
d<
NDIM; ++
d) Rnorm *= ops_1d[
d]->Rnorm;
575 if (Rnorm == 0.0)
return;
577 if (Rnorm > 1.e-20) {
579 tol = tol/(Rnorm*
NDIM);
589 for (std::size_t
d=0;
d<
NDIM; ++
d) {
605 trans2[
d]=ops_1d[
d]->R;
611 for (std::size_t
d=0;
d<
NDIM; ++
d) Tnorm *= ops_1d[
d]->Tnorm;
613 if (n > 0 and (Tnorm>1.e-20)) {
620 for (std::size_t
d=0;
d<
NDIM; ++
d) {
636 trans2[
d]=ops_1d[
d]->T;
656 double prodR=1.0, prodT=1.0;
657 for (std::size_t
d=0;
d<
NDIM; ++
d) {
658 prodR *=
ops[
d]->Rnormf;
659 prodT *=
ops[
d]->Tnormf;
666 double prod=1.0,
sum=0.0;
667 for (std::size_t
d=0;
d<
NDIM; ++
d) {
668 double a =
ops[
d]->NSnormf;
669 double b =
ops[
d]->Tnormf;
670 double aa = std::min(
a,
b);
671 double bb = std::max(
a,
b);
673 if (bb > 0.0)
sum +=(
aa/bb);
701 for (
size_t d=0;
d<
NDIM; ++
d) {
702 double dff_tmp = ops_1d[
d]->
N_diff;
703 double duu_tmp = ops_1d[
d]->
N_diff;
704 double udf_tmp = ops_1d[
d]->
N_diff;
707 for (
size_t dd=0; dd<
NDIM; ++dd) {
709 dff_tmp *= ops_1d[dd]->
N_F;
710 duu_tmp *= ops_1d[dd]->
N_up;
712 udf_tmp *= ops_1d[dd]->
N_F;
713 for (
size_t ddd=0; ddd<
NDIM; ++ddd) {
714 if (ddd!=dd) udf += udf_tmp * ops_1d[ddd]->
N_up;
725 for (
int i=1; i<static_cast<int>(
NDIM)-1; ++i)
factorial*=
double(i);
752 for (std::size_t
d=0;
d<
NDIM; ++
d) {
790 for (std::size_t
d=0;
d<
NDIM; ++
d) {
795 op.ops[
d] =
ops[
mu].getop(
d)->mod_nonstandard(op_key);
834 const double munorm =
op.muops[
mu].norm;
835 norm += munorm*munorm;
840 return data.getptr(n,
d);
858 for (
size_t i=0; i<
NDIM; ++i) t[i]=t[i]%2;
872 const double munorm =
op.muops[
mu].norm;
873 norm += munorm*munorm;
886 for (std::size_t
d=1;
d<
NDIM; ++
d) {
899 template<
typename T,
size_t FDIM>
916 for (
int i=0; i<
k; ++i) identity(i,i)=1.0;
922 for (
size_t ii=0; ii<
NDIM; ++ii) matrices[ii+
NDIM]=identity;
924 for (
size_t ii=0; ii<
NDIM; ++ii) matrices[ii]=identity;
942 template<
typename T,
size_t FDIM>
951 for (
size_t ii=0; ii<FDIM; ++ii) matrices[ii]=
h[key.
translation()[ii]%2];
962 for (
int d = 0;
d !=
NDIM; ++
d) {
963 for(
const auto &
op:
ops) {
975 for (
int d = 0;
d !=
NDIM; ++
d) {
976 for (
const auto &
op :
ops) {
978 ops[0].lattice_summed());
1001 ,
rank(argops.size())
1007 for (
unsigned int mu=0;
mu < argops.size(); ++
mu) {
1031 ,
rank(argops.size())
1054 range =
info.template range_as_array<NDIM>();
1076 ,
rank(coeff.dim(0))
1090 Q c = std::pow(sqrt(expnt(
mu)/
pi),
static_cast<int>(
NDIM));
1096 for (std::size_t
d=0;
d<
NDIM; ++
d) {
1098 lattice_range[
d], bloch_k[
d],
range[
d]));
1107 timer_full.
print(
"op full tensor ");
1138 return getop(n,
d, source_key)->norm;
1148 template<
size_t FDIM>
1149 typename std::enable_if<FDIM!=NDIM, Key<NDIM> >
::type
1165 template<
size_t FDIM>
1166 typename std::enable_if<FDIM==NDIM, Key<NDIM> >
::type
1178 template <
typename T,
size_t FDIM>
1184 template <
typename T,
size_t FDIM>
1194 template <
typename T,
size_t LDIM>
1206 template <
typename T,
size_t LDIM>
1215 template<
typename argT>
1228 template <
typename T>
1243 if (coeff.
dim(0) ==
k) {
1259 tol = 0.01*tol/
rank;
1282 if (muop.
norm > tol) {
1284 Q fac =
ops[
mu].getfac();
1290 r(
s0).gaxpy(1.0,r0,1.0);
1310 template<
typename T>
1321 const std::vector<Slice> s00(coeff.
ndim(),
Slice(0,
k-1));
1341 tol = tol/
rank*0.01;
1349 for (
int r=0; r<coeff.
rank(); ++r) {
1369 Q fac =
ops[
mu].getfac();
1371 tol/
std::abs(fac), fac, work1, work2);
1376 final.get_svdtensor().ref_vector(
particle()-1)(s)=result;
1391 final.reduce_rank(tol2*0.5);
1406 template <
typename T>
1410 double tol,
double tol2)
const {
1423 if (coeff.
dim(0) ==
k) {
1454 std::list<GenTensor<T> > r_list;
1455 std::list<GenTensor<T> > r0_list;
1464 if (muop.
norm > tol) {
1479 Q fac =
ops[
mu].getfac();
1481 tol/
std::abs(fac), fac, work1, work2);
1485 r_list.push_back(r);
1486 r0_list.push_back(r0);
1495 if (r_list.size()>0) r_list.front()(
s0)+=result0;
1514 template<
typename T>
1518 double tol,
double tol2)
const {
1521 if (2*
NDIM==coeff.
ndim())
return 1.5;
1530 const double full_operator_cost=
pow(coeff.
dim(0),
NDIM+1);
1531 const double low_operator_cost=
pow(coeff.
dim(0),
NDIM/2+1);
1532 const double low_reduction_cost=
pow(coeff.
dim(0),
NDIM/2);
1534 double full_cost=0.0;
1535 double low_cost=0.0;
1537 long initial_rank=0;
1538 long final_rank=sqrt(coeff.
size())*0.05;
1544 if (muop.
norm > tol) {
1550 initial_rank+=nterms;
1552 full_cost+=full_operator_cost;
1555 low_cost=initial_rank*low_operator_cost + initial_rank*final_rank*low_reduction_cost;
1559 if (low_cost>0.0) ratio=full_cost/low_cost;
1575 const Key<NDIM>&
shift,
double tol,
bool do_R,
bool do_T)
const {
1577 if (not (do_R or do_T)) {
1578 print(
"no operator requested in make_tt_representation??");
1590 for (std::size_t
d=0;
d<
NDIM; ++
d) Rnorm *=
op->muops[
mu].ops[
d]->Rnorm;
1591 if (Rnorm>1.e-20) hi=
mu;
1592 if ((Rnorm<1.e-20) and (
mu<hi))
lo=
mu;
1597 long rank_eff=(hi-
lo);
1599 if (do_R and do_T) {
1614 for (
int mu=
lo, r=0;
mu<hi; ++
mu, ++r) {
1616 const Q fac =
ops[
mu].getfac();
1617 const Slice sr0(step*r, step*r, 0);
1618 const Slice sr1(step*r+step-1,step*r+step-1,0);
1619 const Slice s00(0,
k-1,1);
1622 cores[0](
_,
_ ,sr0)=muop.
ops[0]->R;
1623 for (std::size_t idim=1; idim<
NDIM-1; ++idim) {
1624 cores[idim](sr0,
_ ,
_ ,sr0)=muop.
ops[idim]->R;
1630 cores[0](s00,s00,sr1)=muop.
ops[0]->T;
1631 for (std::size_t idim=1; idim<
NDIM-1; ++idim) {
1632 cores[idim](sr1,s00,s00,sr1)=muop.
ops[idim]->T;
1634 cores[
NDIM-1](sr1,s00,s00)=muop.
ops[
NDIM-1]->T*(-fac);
1685 MADNESS_EXCEPTION(
"unknown combination of SeparatedConvolutions: feel free to extend in operator.h",1);
1699 for (std::size_t i = 0; i <
NDIM; ++i) {
1711 if (left and right) {
1712 return combine(*left, *right);
1736 const std::array<KernelRange, 3>& kernel_ranges = std::array<KernelRange, 3>(),
1740 lattice_ranges,
k,
false, bloch_k);
1770 template <std::
size_t NDIM>
1772 SeparatedConvolution<double,NDIM>
1777 if (world.
rank()==0)
print(
"the accuracy in BSHOperator is too small, tighten the threshold",eps);
1784 template <std::
size_t NDIM>
1786 SeparatedConvolution<double,NDIM>*
1791 if (world.
rank()==0)
print(
"the accuracy in BSHOperator is too small, tighten the threshold",eps);
1799 static inline SeparatedConvolution<double,3>
1814 const std::array<KernelRange, 3>& kernel_ranges = std::array<KernelRange, 3>(),
1820 lattice_ranges,
k,
false, bloch_k);
1830 const std::array<KernelRange, 3>& kernel_ranges = std::array<KernelRange, 3>(),
1836 lattice_ranges,
k,
false, bloch_k);
1840 static inline SeparatedConvolution<double,3>
1848 double mu,
double lo,
double eps,
1855 double mu,
double lo,
double eps,
1862 template<std::
size_t NDIM=3>
1864 double mu,
double lo,
double eps,
1873 template<std::
size_t NDIM>
1875 double mu,
double lo=0.0,
double eps=0.0,
1884 template<std::
size_t NDIM>
1886 double mu,
double lo=0.0,
double eps=0.0,
1895 template<std::
size_t NDIM>
1897 double mu,
double lo,
double eps,
1906 double mu,
double lo,
double eps,
1916 double mu,
double lo,
double eps,
1927 static inline SeparatedConvolution<double,3>
1938 static inline SeparatedConvolution<double,3>*
1950 static inline SeparatedConvolution<double,3>*
1962 static inline SeparatedConvolution<double,3>
1977 double exponent = 1.0/(2.0*eps);
1979 exponents(0
L) = exponent;
1980 coeffs(0
L)=
pow(exponent/M_PI,0.5*3.0);
1986 template<std::
size_t NDIM>
1992 double exponent = 1.0/(2.0*eps);
1994 exponents(0
L) = exponent;
1995 coeffs(0
L)=
pow(exponent/M_PI,0.5*
NDIM);
2009 double hi = cell_width.
normf();
2012 const auto lattice_summed_any = std::any_of(lattice_ranges.begin(), lattice_ranges.end(), [](
const auto&
b) { return static_cast<bool>(b);});
2013 const auto infinite_any = std::any_of(lattice_ranges.begin(), lattice_ranges.end(), [](
const auto&
b) { return b.infinite();});
2014 if (lattice_summed_any) {
2025 double max_lattice_spacing = 0;
2026 for(
int d=0;
d!=3; ++
d) {
2027 if (lattice_ranges[
d])
2028 max_lattice_spacing =
2029 std::max(max_lattice_spacing, cell_width(
d));
2033 fit.truncate_periodic_expansion(coeff, expnt, max_lattice_spacing,
2047 std::vector< std::shared_ptr< SeparatedConvolution<double,3> > >
2057 double hi = width.
normf();
2059 const auto lattice_sum_any = std::any_of(lattice_ranges.begin(), lattice_ranges.end(), [](
const LatticeRange&
b){ return static_cast<bool>(b); });
2060 if (lattice_sum_any) {
2068 if (lattice_sum_any) {
2069 fit.truncate_periodic_expansion(coeff, expnt, width.
max(),
true);
2072 int rank = coeff.
dim(0);
2074 std::vector<real_convolution_3d_ptr> gradG(3);
2077 std::vector<ConvolutionND<double, 3>> ops(rank);
2078 for (
int mu = 0;
mu < rank;
mu++) {
2080 double c = std::pow(sqrt(expnt(
mu) /
pi), 3);
2081 ops[
mu].setfac(coeff(
mu) /
c / width[
dir]);
2083 for (
int d = 0;
d < 3;
d++) {
2086 k, expnt(
mu) * width[
d] * width[
d], 0,
2087 lattice_ranges[
d]));
2090 k, expnt(
mu) * width[
dir] * width[
dir], 1,
2091 lattice_ranges[
dir]));
2106 std::vector< std::shared_ptr< SeparatedConvolution<double,3> > >
2117 double hi = width.
normf();
2119 bool lattice_sum_any = std::any_of(lattice_ranges.begin(), lattice_ranges.end(), [](
const LatticeRange&
b){ return b.get_range(); });
2120 if (lattice_sum_any) {
2128 if (lattice_sum_any) {
2129 fit.truncate_periodic_expansion(coeff, expnt, width.
max(),
true);
2132 int rank = coeff.
dim(0);
2134 std::vector<real_convolution_3d_ptr> gradG(3);
2137 std::vector<ConvolutionND<double, 3>> ops(rank);
2138 for (
int mu = 0;
mu < rank;
mu++) {
2140 double c = std::pow(sqrt(expnt(
mu) /
pi), 3);
2141 ops[
mu].setfac(coeff(
mu) /
c / width[
dir]);
2143 for (
int d = 0;
d < 3;
d++) {
2146 k, expnt(
mu) * width[
d] * width[
d], 0,
2147 lattice_ranges[
d]));
2150 k, expnt(
mu) * width[
dir] * width[
dir], 1,
2151 lattice_ranges[
dir]));
2163 template <
class Archive,
class T, std::
size_t NDIM>
2172 template <
class Archive,
class T, std::
size_t NDIM>
double q(double t)
Definition DKops.h:18
Provides routines for internal use optimized for aligned data.
long dim(int i) const
Returns the size of dimension i.
Definition basetensor.h:147
long ndim() const
Returns the number of dimensions in the tensor.
Definition basetensor.h:144
Provides the common functionality/interface of all 1D convolutions.
Definition convolution1d.h:259
Array of 1D convolutions (one / dimension)
Definition convolution1d.h:585
Holds displacements for applying operators to avoid replicating for all operators.
Definition displacements.h:64
const std::vector< Key< NDIM > > & get_disp(Level n, const array_of_bools< NDIM > &kernel_lattice_sum_axes)
Definition displacements.h:224
FunctionCommonData holds all Function data common for given k.
Definition function_common_data.h:52
Tensor< double > h0
Definition function_common_data.h:105
Tensor< double > h1
Definition function_common_data.h:105
FunctionDefaults holds default paramaters as static class members.
Definition funcdefaults.h:100
static const Tensor< double > & get_cell_width()
Returns the width of each user cell dimension.
Definition funcdefaults.h:370
A multiresolution adaptive numerical function.
Definition mra.h:139
static GFit BSHFit(double mu, double lo, double hi, double eps, bool prnt=false)
return a fit for the bound-state Helmholtz function
Definition gfit.h:117
static GFit CoulombFit(double lo, double hi, double eps, bool prnt=false)
return a fit for the Coulomb function
Definition gfit.h:102
Definition lowranktensor.h:59
long dim(const int i) const
return the number of entries in dimension i
Definition lowranktensor.h:391
long ndim() const
Definition lowranktensor.h:386
constexpr bool is_full_tensor() const
Definition gentensor.h:224
void reduce_rank(const double &eps)
Definition gentensor.h:217
long rank() const
Definition gentensor.h:212
long size() const
Definition lowranktensor.h:482
SVDTensor< T > & get_svdtensor()
Definition gentensor.h:228
const BaseTensor * ptr() const
might return a NULL pointer!
Definition lowranktensor.h:709
IsSupported< TensorTypeData< Q >, GenTensor< T > & >::type scale(Q fac)
Inplace multiplication by scalar of supported type (legacy name)
Definition lowranktensor.h:426
constexpr bool is_svd_tensor() const
Definition gentensor.h:222
Key is the index for a node of the 2^NDIM-tree.
Definition key.h:69
Key< NDIM+LDIM > merge_with(const Key< LDIM > &rhs) const
merge with other key (ie concatenate), use level of rhs, not of this
Definition key.h:406
const Vector< Translation, NDIM > & translation() const
Definition key.h:173
void break_apart(Key< LDIM > &key1, Key< KDIM > &key2) const
break key into two low-dimensional keys
Definition key.h:343
Denotes lattice summation over range [-N, N]; N=0 is equivalent to including the simulation cell only...
Definition kernelrange.h:17
Tensor< T > & ref_vector(const unsigned int &idim)
return reference to one of the vectors F
Definition srconf.h:530
int dim_per_vector(int idim) const
return the number of physical dimensions
Definition srconf.h:665
static int max_sigma(const double &thresh, const long &rank, const Tensor< double > &w)
Definition srconf.h:109
Definition SVDTensor.h:42
Convolutions in separated form (including Gaussian)
Definition operator.h:139
SeparatedConvolution(World &world, const Tensor< Q > &coeff, const Tensor< double > &expnt, double lo, double thresh, const std::array< LatticeRange, NDIM > &lattice_ranges=FunctionDefaults< NDIM >::get_bc().lattice_range(), int k=FunctionDefaults< NDIM >::get_k(), bool doleaves=false, double mu=0.0)
Constructor for Gaussian Convolutions (mostly for backward compatability)
Definition operator.h:1061
Timer timer_low_transf
Definition operator.h:165
bool destructive_
destroy the argument or restore it (expensive for 6d functions)
Definition operator.h:159
GenTensor< TENSOR_RESULT_TYPE(T, Q)> apply2(const Key< NDIM > &source, const Key< NDIM > &shift, const GenTensor< T > &coeff, double tol, double tol2) const
apply this operator on coefficients in low rank form
Definition operator.h:1407
std::array< KernelRange, NDIM > range
kernel range is along axis d is limited by range[d] if it's nonnull
Definition operator.h:154
const array_of_bools< NDIM > & lattice_summed() const
Definition operator.h:1126
int particle_
must only be 1 or 2
Definition operator.h:158
void muopxv_fast2(Level n, const ConvolutionData1D< Q > *const ops_1d[NDIM], const GenTensor< T > &f, const GenTensor< T > &f0, GenTensor< TENSOR_RESULT_TYPE(T, Q)> &result, GenTensor< TENSOR_RESULT_TYPE(T, Q)> &result0, double tol, const Q mufac, GenTensor< TENSOR_RESULT_TYPE(T, Q)> &work1, GenTensor< TENSOR_RESULT_TYPE(T, Q)> &work2) const
Apply one of the separated terms, accumulating into the result.
Definition operator.h:558
const double & gamma() const
Definition operator.h:200
GenTensor< TENSOR_RESULT_TYPE(T, Q)> apply2_lowdim(const Key< NDIM > &source, const Key< NDIM > &shift, const GenTensor< T > &coeff, double tol, double tol2) const
apply this operator on only 1 particle of the coefficients in low rank form
Definition operator.h:1311
std::vector< ConvolutionND< Q, NDIM > > ops
ConvolutionND keeps data for 1 term, all dimensions, 1 displacement.
Definition operator.h:172
Function< TENSOR_RESULT_TYPE(T, Q), LDIM+LDIM > operator()(const Function< T, LDIM > &f1, const Function< Q, LDIM > &f2) const
apply this operator on a separable function f(1,2) = f(1) f(2)
Definition operator.h:1196
const SeparatedConvolutionData< Q, NDIM > * getop(Level n, const Key< NDIM > &d, const Key< NDIM > &source) const
get the data for all terms and all dimensions for one displacement
Definition operator.h:805
void set_domain_periodicity(const array_of_bools< NDIM > &domain_is_periodic)
Definition operator.h:1132
const double & mu() const
Definition operator.h:201
double munorm2(Level n, const ConvolutionData1D< Q > *ops[]) const
Definition operator.h:645
const bool & destructive() const
Definition operator.h:198
Timer timer_stats_accumulate
Definition operator.h:167
SimpleCache< SeparatedConvolutionData< Q, NDIM >, NDIM > data
cache for all terms, dims and displacements
Definition operator.h:181
std::enable_if< FDIM!=NDIM, Key< NDIM > >::type get_source_key(const Key< FDIM > key) const
return that part of a hi-dim key that serves as the base for displacements of this operator
Definition operator.h:1150
double munorm2_ns(Level n, const ConvolutionData1D< Q > *ops[]) const
Definition operator.h:653
std::enable_if< FDIM==NDIM, Key< NDIM > >::type get_source_key(const Key< FDIM > key) const
return that part of a hi-dim key that serves as the base for displacements of this operator
Definition operator.h:1167
virtual ~SeparatedConvolution()
Definition operator.h:1103
void muopxv_fast(ApplyTerms at, const ConvolutionData1D< Q > *const ops_1d[NDIM], const Tensor< T > &f, const Tensor< T > &f0, Tensor< TENSOR_RESULT_TYPE(T, Q)> &result, Tensor< TENSOR_RESULT_TYPE(T, Q)> &result0, const double tol, const Q mufac, Tensor< TENSOR_RESULT_TYPE(T, Q)> &work1, Tensor< TENSOR_RESULT_TYPE(T, Q)> &work2) const
Apply one of the separated terms, accumulating into the result.
Definition operator.h:447
SimpleCache< SeparatedConvolutionData< Q, NDIM >, 2 *NDIM > mod_data
cache for all terms, dims and displacements
Definition operator.h:182
argT operator()(const argT &argument) const
apply this onto another suitable argument, returning the same type
Definition operator.h:1216
Timer timer_full
Definition operator.h:164
const array_of_bools< NDIM > & func_domain_is_periodic() const
Definition operator.h:1129
SeparatedConvolution< Q, NDIM > & set_particle(const int p)
Definition operator.h:191
SeparatedConvolution(World &world, const std::vector< std::shared_ptr< Convolution1D< Q > > > &argops, long k=FunctionDefaults< NDIM >::get_k(), bool doleaves=false)
Definition operator.h:988
Function< TENSOR_RESULT_TYPE(T, Q), LDIM+LDIM > operator()(const std::vector< Function< T, LDIM > > &f1, const std::vector< Function< Q, LDIM > > &f2) const
apply this operator on a sum of separable functions f(1,2) = \sum_i f_i(1) f_i(2)
Definition operator.h:1208
void init_lattice_summed()
Definition operator.h:973
Q opT
The apply function uses this to infer resultT=opT*inputT.
Definition operator.h:142
void initialize(const Tensor< Q > &coeff, const Tensor< double > &expnt, std::array< LatticeRange, NDIM > lattice_range, std::array< KernelRange, NDIM > range={}, const Vector< double, NDIM > &bloch_k=Vector< double, NDIM >(0.0))
Definition operator.h:1085
const SeparatedConvolutionInternal< Q, NDIM > getmuop(int mu, Level n, const Key< NDIM > &disp) const
get the transformation matrices for 1 term and all dimensions and one displacement
Definition operator.h:749
const SeparatedConvolutionData< Q, NDIM > * getop_ns(Level n, const Key< NDIM > &d) const
get the data for all terms and all dimensions for one displacement
Definition operator.h:819
const std::vector< long > v2k
Definition operator.h:177
const std::array< KernelRange, NDIM > & get_range() const
Definition operator.h:205
int get_rank() const
Definition operator.h:202
Function< TENSOR_RESULT_TYPE(T, Q), FDIM > operator()(const Function< T, FDIM > &f) const
apply this operator on a function f
Definition operator.h:1179
bool doleaves
If should be applied to leaf coefficients ... false by default.
Definition operator.h:146
void print_timer() const
Definition operator.h:1105
SeparatedConvolution(World &world, const std::vector< ConvolutionND< Q, NDIM > > &argops, long k=FunctionDefaults< NDIM >::get_k(), bool doleaves=false)
Definition operator.h:1017
const std::vector< Key< NDIM > > & get_disp(Level n) const
Definition operator.h:1121
void apply_transformation3(const Tensor< T > trans2[NDIM], const Tensor< T > &f, const Q mufac, Tensor< R > &result) const
accumulate into result
Definition operator.h:370
static SeparatedConvolution< Q, NDIM > combine(const SeparatedConvolution< Q, NDIM > &left, const SeparatedConvolution< Q, NDIM > &right)
Definition operator.h:1693
const std::vector< long > vk
Definition operator.h:176
double norm(Level n, const Key< NDIM > &d, const Key< NDIM > &source_key) const
return the operator norm for all terms, all dimensions and 1 displacement
Definition operator.h:1135
TensorTrain< double > make_tt_representation(const Key< NDIM > &source, const Key< NDIM > &shift, double tol, bool do_R, bool do_T) const
construct the tensortrain representation of the operator
Definition operator.h:1574
void reset_timer() const
Definition operator.h:1113
static OperatorInfo combine_OT(const SeparatedConvolution< Q, NDIM > &left, const SeparatedConvolution< Q, NDIM > &right)
return operator type and other info of the combined operator (e.g. fg = f(1,2)* g(1,...
Definition operator.h:1655
GenTensor< T > upsample(const Key< FDIM > &key, const GenTensor< T > &coeff) const
upsample the sum coefficients of level 1 to sum coeffs on level n+1
Definition operator.h:943
bool print_timings
Definition operator.h:160
Timer timer_low_accumulate
Definition operator.h:166
double estimate_costs(const Key< NDIM > &source, const Key< NDIM > &shift, const GenTensor< T > &coeff, double tol, double tol2) const
estimate the ratio of cost of full rank versus low rank
Definition operator.h:1515
bool range_restricted() const
Definition operator.h:206
int get_k() const
Definition operator.h:203
Tensor< TENSOR_RESULT_TYPE(T, Q)> apply(const Key< NDIM > &source, const Key< NDIM > &shift, const Tensor< T > &coeff, double tol) const
apply this operator on coefficients in full rank form
Definition operator.h:1229
const std::vector< Slice > s0
Definition operator.h:178
array_of_bools< NDIM > lattice_summed_
Definition operator.h:150
void apply_transformation2(Level n, long dimk, double tol, const Tensor< T > trans2[NDIM], const GenTensor< T > &f, GenTensor< R > &work1, GenTensor< R > &work2, const Q mufac, GenTensor< R > &result) const
don't accumulate, since we want to do this at apply()
Definition operator.h:387
const int & particle() const
Definition operator.h:190
std::vector< Function< TENSOR_RESULT_TYPE(T, Q), FDIM > > operator()(const std::vector< Function< T, FDIM > > &f) const
apply this on a vector of functions
Definition operator.h:1185
const bool & modified() const
Definition operator.h:187
const FunctionCommonData< Q, NDIM > & cdata
Definition operator.h:174
bool & modified()
Definition operator.h:186
const int k
Definition operator.h:173
friend SeparatedConvolution< Q, NDIM > combine(const std::shared_ptr< SeparatedConvolution< Q, NDIM > > left, const std::shared_ptr< SeparatedConvolution< Q, NDIM > > right)
combine 2 convolution operators to one
Definition operator.h:1708
OperatorInfo info
Definition operator.h:144
Key< NDIM > keyT
Definition operator.h:162
void init_range()
Definition operator.h:960
static const size_t opdim
Definition operator.h:163
bool & destructive()
Definition operator.h:197
void apply_transformation(long dimk, const Transformation trans[NDIM], const Tensor< T > &f, Tensor< R > &work1, Tensor< R > &work2, const Q mufac, Tensor< R > &result) const
Definition operator.h:307
static std::pair< Tensor< double >, Tensor< double > > make_coeff_for_operator(World &world, OperatorInfo &info, const std::array< LatticeRange, NDIM > &lattice_ranges)
Definition operator.h:226
void check_cubic()
Definition operator.h:882
bool modified_
use modified NS form
Definition operator.h:157
int rank
Definition operator.h:175
SeparatedConvolution(World &world, const OperatorInfo info1, const std::array< LatticeRange, NDIM > &lattice_ranges=FunctionDefaults< NDIM >::get_bc().lattice_range(), int k=FunctionDefaults< NDIM >::get_k(), bool doleaves=false, const Vector< double, NDIM > &bloch_k=Vector< double, NDIM >(0.0))
Definition operator.h:1043
GenTensor< T > partial_upsample(const Key< FDIM > &key, const GenTensor< T > &coeff, const int particle) const
upsample some of the dimensions of coeff to its child indicated by key
Definition operator.h:900
double munorm2_modified(Level n, const ConvolutionData1D< Q > *ops_1d[]) const
Definition operator.h:686
int & particle()
Definition operator.h:189
static bool can_combine(const SeparatedConvolution< Q, NDIM > &left, const SeparatedConvolution< Q, NDIM > &right)
Definition operator.h:1650
const std::vector< ConvolutionND< Q, NDIM > > & get_ops() const
Definition operator.h:204
const SeparatedConvolutionData< Q, NDIM > * getop_modified(Level n, const Key< NDIM > &disp, const Key< NDIM > &source) const
get the data for all terms and all dimensions for one displacement (modified NS form)
Definition operator.h:853
array_of_bools< NDIM > func_domain_is_periodic_
ignore periodicity of BC when applying this to function
Definition operator.h:152
const SeparatedConvolutionInternal< Q, NDIM > getmuop_modified(int mu, Level n, const Key< NDIM > &disp, const Key< NDIM > &source) const
get the transformation matrices for 1 term and all dimensions and one displacement
Definition operator.h:778
Simplified interface around hash_map to cache stuff for 1D.
Definition simplecache.h:46
A slice defines a sub-range or patch of a dimension.
Definition slice.h:103
Definition tensortrain.h:123
std::enable_if<!std::is_arithmetic< R >::value, void >::type truncate(double eps)
recompress and truncate this TT representation
Definition tensortrain.h:883
TensorTrain< T > & make_operator()
convert this into an operator representation (r,k',k,r)
Definition tensortrain.h:1188
TensorTrain< T > & make_tensor()
convert this into a tensor representation (r,k,r)
Definition tensortrain.h:1176
A tensor is a multidimensional array.
Definition tensor.h:317
float_scalar_type normf() const
Returns the Frobenius norm of the tensor.
Definition tensor.h:1726
T * ptr()
Returns a pointer to the internal data.
Definition tensor.h:1840
IsSupported< TensorTypeData< Q >, Tensor< T > & >::type scale(Q x)
Inplace multiplication by scalar of supported type (legacy name)
Definition tensor.h:686
T max(long *ind=0) const
Return the maximum value (and if ind is non-null, its index) in the Tensor.
Definition tensor.h:1703
Definition function_common_data.h:169
void print(std::string line="") const
print timer
Definition function_common_data.h:216
void accumulate(const double time) const
accumulate timer
Definition function_common_data.h:183
void reset() const
Definition function_common_data.h:210
A simple, fixed dimension vector.
Definition vector.h:64
Implements most parts of a globally addressable object (via unique ID).
Definition world_object.h:366
World & get_world() const
Returns a reference to the world.
Definition world_object.h:719
World & world
The World this object belongs to. (Think globally, act locally).
Definition world_object.h:383
void process_pending()
To be called from derived constructor to process pending messages.
Definition world_object.h:658
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
unsigned long id() const
Definition world.h:315
syntactic sugar for std::array<bool, N>
Definition array_of_bools.h:19
Defines common mathematical and physical constants.
Computes most matrix elements over 1D operators (including Gaussians)
static const double R
Definition csqrt.cc:46
double(* f1)(const coord_3d &)
Definition derivatives.cc:55
char * p(char *buf, const char *name, int k, int initial_level, double thresh, int order)
Definition derivatives.cc:72
double(* f2)(const coord_3d &)
Definition derivatives.cc:56
static double lo
Definition dirac-hatom.cc:23
static double shift
Definition dirac-hatom.cc:19
fit isotropic functions to a set of Gaussians with controlled precision
auto T(World &world, response_space &f) -> response_space
Definition global_functions.cc:28
static const double v
Definition hatom_sf_dirac.cc:20
Tensor< double > op(const Tensor< double > &x)
Definition kain.cc:508
static double pow(const double *a, const double *b)
Definition lda.h:74
#define max(a, b)
Definition lda.h:51
#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
#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
constexpr double pi
Mathematical constant .
Definition constants.h:48
Namespace for all elements and tools of MADNESS.
Definition DFParameters.h:10
static SeparatedConvolution< double, 3 > SlaterF12Operator(World &world, double mu, double lo, double eps, const std::array< LatticeRange, 3 > &lattice_ranges=FunctionDefaults< 3 >::get_bc().lattice_range(), int k=FunctionDefaults< 3 >::get_k())
Definition operator.h:1841
array_of_bools< NDIM > lattice_sum()
Definition bc.h:248
static SeparatedConvolution< double_complex, 3 > PeriodicBSHOperator3D(World &world, Vector< double, 3 > bloch_k, double mu, double lo, double eps, const std::array< KernelRange, 3 > &kernel_ranges=std::array< KernelRange, 3 >(), const std::array< LatticeRange, 3 > &lattice_ranges=FunctionDefaults< 3 >::get_bc().lattice_range(), int k=FunctionDefaults< 3 >::get_k())
Factory function generating separated kernel for convolution with exp(-mu*r)/(4*pi*r) in 3D.
Definition operator.h:1809
static SeparatedConvolution< double, NDIM > * GaussOperatorPtr(World &world, double mu, double lo=0.0, double eps=0.0, const array_of_bools< NDIM > &lattice_sum=FunctionDefaults< NDIM >::get_bc().is_periodic(), int k=FunctionDefaults< NDIM >::get_k())
Factory function generating separated kernel for convolution with exp(-mu*r*r) in 3D.
Definition operator.h:1885
std::shared_ptr< real_convolution_3d > real_convolution_3d_ptr
Definition functypedefs.h:150
static double cpu_time()
Returns the cpu time in seconds relative to an arbitrary origin.
Definition timers.h:127
SeparatedConvolution< double, 3 > real_convolution_3d
Definition functypedefs.h:136
GenTensor< TENSOR_RESULT_TYPE(R, Q)> general_transform(const GenTensor< R > &t, const Tensor< Q > c[])
Definition gentensor.h:274
void fast_transpose(long n, long m, const T *a, T *MADNESS_RESTRICT b)
a(n,m) --> b(m,n) ... optimized for smallish matrices
Definition convolution1d.h:71
static SeparatedConvolution< double, NDIM > SmoothingOperator(World &world, double eps, const std::array< LatticeRange, NDIM > &lattice_ranges=FunctionDefaults< NDIM >::get_bc().lattice_range(), int k=FunctionDefaults< NDIM >::get_k())
Definition operator.h:1987
static SeparatedConvolution< double, 3 > F2GOperator(World &world, double mu, double lo, double eps, const std::array< LatticeRange, 3 > &lattice_ranges=FunctionDefaults< 3 >::get_bc().lattice_range(), int k=FunctionDefaults< 3 >::get_k())
Factory function generating separated kernel for convolution with (1/(2 mu)*(1 - exp(-mu*r)))^2/r in ...
Definition operator.h:1963
static SeparatedConvolution< double, 3 > CoulombOperator(World &world, double lo, double eps, const std::array< LatticeRange, 3 > &lattice_ranges=FunctionDefaults< 3 >::get_bc().lattice_range(), int k=FunctionDefaults< 3 >::get_k())
Factory function generating separated kernel for convolution with 1/r in 3D.
Definition operator.h:1746
static SeparatedConvolution< double, NDIM > * BSHOperatorPtr(World &world, double mu, double lo, double eps, const std::array< LatticeRange, NDIM > &lattice_ranges=FunctionDefaults< NDIM >::get_bc().lattice_range(), int k=FunctionDefaults< NDIM >::get_k())
Factory function generating separated kernel for convolution with BSH kernel in general NDIM.
Definition operator.h:1787
static SeparatedConvolution< double, NDIM > GaussOperator(World &world, double mu, double lo=0.0, double eps=0.0, const array_of_bools< NDIM > &lattice_sum=FunctionDefaults< NDIM >::get_bc().is_periodic(), int k=FunctionDefaults< NDIM >::get_k())
Factory function generating separated kernel for convolution with exp(-mu*r*r)
Definition operator.h:1874
static SeparatedConvolution< double, 3 > * F2GOperatorPtr(World &world, double mu, double lo, double eps, const std::array< LatticeRange, 3 > &lattice_ranges=FunctionDefaults< 3 >::get_bc().lattice_range(), int k=FunctionDefaults< 3 >::get_k())
Factory function generating separated kernel for convolution with (1/(2 mu)*(1 - exp(-mu*r)))^2/r in ...
Definition operator.h:1951
int64_t Translation
Definition key.h:57
static SeparatedConvolution< double, 3 > * SlaterOperatorPtr(World &world, double mu, double lo, double eps, const std::array< LatticeRange, 3 > &lattice_ranges=FunctionDefaults< 3 >::get_bc().lattice_range(), int k=FunctionDefaults< 3 >::get_k())
Definition operator.h:1905
static SeparatedConvolution< double, 3 > SlaterF12sqOperator(World &world, double mu, double lo, double eps, const std::array< LatticeRange, 3 > &lattice_ranges=FunctionDefaults< 3 >::get_bc().lattice_range(), int k=FunctionDefaults< 3 >::get_k())
Definition operator.h:1847
static SeparatedConvolution< double, 3 > SmoothingOperator3D(World &world, double eps, const std::array< LatticeRange, 3 > &lattice_ranges=FunctionDefaults< 3 >::get_bc().lattice_range(), int k=FunctionDefaults< 3 >::get_k())
Definition operator.h:1972
void mTxmq_padding(long dimi, long dimj, long dimk, long ext_b, cT *c, const aT *a, const bT *b)
Definition mtxmq.h:96
static const Slice _(0,-1, 1)
static SeparatedConvolution< double, 3 > * SlaterF12OperatorPtr(World &world, double mu, double lo, double eps, const std::array< LatticeRange, 3 > &lattice_ranges=FunctionDefaults< 3 >::get_bc().lattice_range(), int k=FunctionDefaults< 3 >::get_k())
Factory function generating separated kernel for convolution with (1 - exp(-mu*r))/(2 mu) in 3D.
Definition operator.h:1915
int Level
Definition key.h:58
@ OT_FG12
1-exp(-r)
Definition operatorinfo.h:18
@ OT_SLATER
1/r
Definition operatorinfo.h:15
@ OT_GAUSS
exp(-r)
Definition operatorinfo.h:16
@ OT_BSH
(1-exp(-r))^2/r = 1/r + exp(-2r)/r - 2 exp(-r)/r
Definition operatorinfo.h:21
@ OT_F12
exp(-r2)
Definition operatorinfo.h:17
@ OT_F212
(1-exp(-r))/r
Definition operatorinfo.h:19
@ OT_UNDEFINED
Definition operatorinfo.h:12
@ OT_G12
indicates the identity
Definition operatorinfo.h:14
@ OT_F2G12
(1-exp(-r))^2
Definition operatorinfo.h:20
static SeparatedConvolution< double_complex, 3 > PeriodicHFExchangeOperator(World &world, Vector< double, 3 > bloch_k, double lo, double eps, const std::array< KernelRange, 3 > &kernel_ranges=std::array< KernelRange, 3 >(), const std::array< LatticeRange, 3 > &lattice_ranges=FunctionDefaults< 3 >::get_bc().lattice_range(), int k=FunctionDefaults< 3 >::get_k())
Definition operator.h:1732
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:226
response_space apply(World &world, std::vector< std::vector< std::shared_ptr< real_convolution_3d > > > &op, response_space &f)
Definition basic_operators.cc:43
static std::vector< std::shared_ptr< SeparatedConvolution< double, 3 > > > GradBSHOperator(World &world, double mu, double lo, double eps, const std::array< LatticeRange, 3 > &lattice_ranges=FunctionDefaults< 3 >::get_bc().lattice_range(), int k=FunctionDefaults< 3 >::get_k())
Factory function generating operator for convolution with grad(bsh) in 3D.
Definition operator.h:2107
static SeparatedConvolution< double, 3 > * SlaterF12sqOperatorPtr(World &world, double mu, double lo, double eps, const std::array< LatticeRange, 3 > &lattice_ranges=FunctionDefaults< 3 >::get_bc().lattice_range(), int k=FunctionDefaults< 3 >::get_k())
Definition operator.h:1854
TensorType
low rank representations of tensors (see gentensor.h)
Definition gentensor.h:120
@ TT_2D
Definition gentensor.h:120
NDIM & f
Definition mra.h:2528
static SeparatedConvolution< double, NDIM > SlaterOperator(World &world, double mu, double lo, double eps, const std::array< LatticeRange, 3 > &lattice_ranges=FunctionDefaults< NDIM >::get_bc().lattice_range(), int k=FunctionDefaults< NDIM >::get_k())
Factory function generating separated kernel for convolution with exp(-mu*r) in 3D.
Definition operator.h:1863
GenTensor< T > reduce(std::list< GenTensor< T > > &addends, double eps, bool are_optimal=false)
add all the GenTensors of a given list
Definition gentensor.h:246
static SeparatedConvolution< double, NDIM > BSHOperator(World &world, double mu, double lo, double eps, const std::array< LatticeRange, NDIM > &lattice_ranges=FunctionDefaults< NDIM >::get_bc().lattice_range(), int k=FunctionDefaults< NDIM >::get_k())
Factory function generating separated kernel for convolution with BSH kernel in general NDIM.
Definition operator.h:1773
static SeparatedConvolution< double, 3 > * CoulombOperatorPtr(World &world, double lo, double eps, const std::array< LatticeRange, 3 > &lattice_ranges=FunctionDefaults< 3 >::get_bc().lattice_range(), int k=FunctionDefaults< 3 >::get_k())
Factory function generating separated kernel for convolution with 1/r in 3D.
Definition operator.h:1759
std::string type(const PairType &n)
Definition PNOParameters.h:18
static SeparatedConvolution< double, 3 > FGOperator(World &world, double mu, double lo, double eps, const std::array< LatticeRange, 3 > &lattice_ranges=FunctionDefaults< 3 >::get_bc().lattice_range(), int k=FunctionDefaults< 3 >::get_k())
Factory function generating separated kernel for convolution with 1/(2 mu)*(1 - exp(-mu*r))/r in 3D.
Definition operator.h:1928
static SeparatedConvolution< double_complex, 3 > * PeriodicBSHOperatorPtr3D(World &world, Vector< double, 3 > bloch_k, double mu, double lo, double eps, const std::array< KernelRange, 3 > &kernel_ranges=std::array< KernelRange, 3 >(), const std::array< LatticeRange, 3 > &lattice_ranges=FunctionDefaults< 3 >::get_bc().lattice_range(), int k=FunctionDefaults< 3 >::get_k())
Factory function generating separated kernel for convolution with exp(-mu*r)/(4*pi*r) in 3D.
Definition operator.h:1825
static SeparatedConvolution< double, 3 > * BSHOperatorPtr3D(World &world, double mu, double lo, double eps, const std::array< LatticeRange, 3 > &lattice_ranges=FunctionDefaults< 3 >::get_bc().lattice_range(), int k=FunctionDefaults< 3 >::get_k())
Factory function generating separated kernel for convolution with exp(-mu*r)/(4*pi*r) in 3D.
Definition operator.h:2002
static SeparatedConvolution< double, NDIM > * SlaterOperatorPtr_ND(World &world, double mu, double lo, double eps, const array_of_bools< NDIM > &lattice_sum=FunctionDefaults< NDIM >::get_bc().is_periodic(), int k=FunctionDefaults< NDIM >::get_k())
Definition operator.h:1896
static SeparatedConvolution< double, 3 > BSHOperator3D(World &world, double mu, double lo, double eps, const std::array< LatticeRange, 3 > &lattice_ranges=FunctionDefaults< 3 >::get_bc().lattice_range(), int k=FunctionDefaults< 3 >::get_k())
Factory function generating separated kernel for convolution with exp(-mu*r)/(4*pi*r) in 3D.
Definition operator.h:1800
static SeparatedConvolution< double, 3 > * FGOperatorPtr(World &world, double mu, double lo, double eps, const std::array< LatticeRange, 3 > &lattice_ranges=FunctionDefaults< 3 >::get_bc().lattice_range(), int k=FunctionDefaults< 3 >::get_k())
Factory function generating separated kernel for convolution with 1/(2 mu)*(1 - exp(-mu*r))/r in 3D.
Definition operator.h:1939
static std::vector< std::shared_ptr< SeparatedConvolution< double, 3 > > > GradCoulombOperator(World &world, double lo, double eps, const std::array< LatticeRange, 3 > &lattice_ranges=FunctionDefaults< 3 >::get_bc().lattice_range(), int k=FunctionDefaults< 3 >::get_k())
Factory function generating operator for convolution with grad(1/r) in 3D.
Definition operator.h:2048
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:2096
void mTxmq(long dimi, long dimj, long dimk, T *MADNESS_RESTRICT c, const T *a, const T *b, long ldb=-1)
Matrix = Matrix transpose * matrix ... MKL interface version.
Definition mxm.h:257
static const string dir
Definition corepotential.cc:249
static void aligned_axpy(long n, T *MADNESS_RESTRICT a, const T *MADNESS_RESTRICT b, Q s)
Definition aligned.h:75
static long abs(long a)
Definition tensor.h:218
const double mu
Definition navstokes_cosines.cc:95
static const double b
Definition nonlinschro.cc:119
static const double d
Definition nonlinschro.cc:121
static const double a
Definition nonlinschro.cc:118
double Q(double a)
Definition relops.cc:20
static const double c
Definition relops.cc:10
static const double L
Definition rk.cc:46
static const double thresh
Definition rk.cc:45
static const long k
Definition rk.cc:44
Definition test_ccpairfunction.cc:22
!!! Note that if Rnormf is zero then ALL of the tensors are empty
Definition convolution1d.h:163
double N_up
Definition convolution1d.h:174
double N_F
the norms according to Beylkin 2008, Eq. (21) ff
Definition convolution1d.h:174
double N_diff
Definition convolution1d.h:174
Definition convolution1d.h:989
Definition operatorinfo.h:58
double hi
Definition operatorinfo.h:67
OpType type
introspection
Definition operatorinfo.h:66
double mu
some introspection
Definition operatorinfo.h:63
std::vector< KernelRange > range
Definition operatorinfo.h:68
std::optional< bool > truncate_lowexp_gaussians
Definition operatorinfo.h:70
SeparatedConvolutionData keeps data for all terms, all dimensions.
Definition operator.h:93
std::vector< SeparatedConvolutionInternal< Q, NDIM > > muops
Definition operator.h:94
SeparatedConvolutionData(int rank)
Definition operator.h:97
double norm
Definition operator.h:95
SeparatedConvolutionData(const SeparatedConvolutionData< Q, NDIM > &q)
Definition operator.h:98
double norm
Definition operator.h:85
const ConvolutionData1D< Q > * ops[NDIM]
Definition operator.h:86
laziness for calling lists: which terms to apply
Definition operator.h:211
bool t_term
Definition operator.h:214
bool r_term
Definition operator.h:213
bool any_terms() const
Definition operator.h:215
ApplyTerms()
Definition operator.h:212
static void load(const Archive &ar, const SeparatedConvolution< T, NDIM > *&ptr)
Definition operator.h:2165
Default load of an object via serialize(ar, t).
Definition archive.h:667
static void store(const Archive &ar, const SeparatedConvolution< T, NDIM > *const &ptr)
Definition operator.h:2174
Default store of an object via serialize(ar, t).
Definition archive.h:612
Definition lowrankfunction.h:336
void doit(World &world)
Definition tdse.cc:921
Prototypes for a partial interface from Tensor to LAPACK.
int factorial(int n)
Definition test_BSHApply.cc:14
AtomicInt sum
Definition test_atomicint.cc:46
void e()
Definition test_sig.cc:75
double aa
Definition testbsh.cc:68
static const double pi
Definition testcosine.cc:6
std::vector< double > fit(size_t m, size_t n, const std::vector< double > N, const std::vector< double > &f)
Definition testfuns.cc:36
constexpr std::size_t NDIM
Definition testgconv.cc:54
double h(const coord_1d &r)
Definition testgconv.cc:175
double source(const coordT &r)
Definition testperiodic.cc:48
#define TENSOR_RESULT_TYPE(L, R)
This macro simplifies access to TensorResultType.
Definition type_data.h:205
#define PROFILE_MEMBER_FUNC(classname)
Definition worldprofile.h:210