3#include <boost/math/special_functions.hpp>
5#include "dg/algorithm.h"
29template<
class ContainerType0,
class ContainerType1,
class ContainerType2,
class ContainerType3>
40 static_assert( std::is_same_v<value_type, double> or std::is_same_v<value_type, float>,
41 "Value type must be either float or double");
42 static_assert( std::is_same_v<dg::get_value_type<ContainerType1>, value_type> &&
43 std::is_same_v<dg::get_value_type<ContainerType2>, value_type> &&
44 std::is_same_v<dg::get_value_type<ContainerType3>, value_type>,
45 "All Vectors must have same value type");
46 static_assert( std::is_same_v<dg::get_execution_policy<ContainerType0>,
dg::SerialTag> &&
47 std::is_same_v<dg::get_execution_policy<ContainerType1>,
dg::SerialTag> &&
48 std::is_same_v<dg::get_execution_policy<ContainerType2>,
dg::SerialTag> &&
49 std::is_same_v<dg::get_execution_policy<ContainerType3>,
dg::SerialTag>,
50 "All Vectors must have serial execution policy");
54 lapack_int N = D.size();
55 value_type * D_ptr = thrust::raw_pointer_cast( &D[0]);
56 value_type * E_ptr = thrust::raw_pointer_cast( &E[0]);
57 value_type * Z_ptr =
nullptr;
59 value_type * work_ptr =
nullptr;
62 Z_ptr = thrust::raw_pointer_cast( &Z[0]);
63 work_ptr = thrust::raw_pointer_cast( &work[0]);
67 if constexpr ( std::is_same_v<value_type, double>)
68 info = LAPACKE_dstev_work( order, job, N, D_ptr, E_ptr, Z_ptr, ldz, work_ptr);
69 else if constexpr ( std::is_same_v<value_type, float>)
70 info = LAPACKE_sstev_work( order, job, N, D_ptr, E_ptr, Z_ptr, ldz, work_ptr);
94template<
class value_type>
101 value_type ci = T.P[0]/T.O[0], ciold = 0.;
102 value_type di = 1./T.O[0], diold = 0.;
103 for(
unsigned i=1; i<size; i++)
105 ciold = ci, diold = di;
106 ci = T.P[i]/ ( T.O[i]-T.M[i]*ciold);
107 di = -T.M[i]*diold/(T.O[i]-T.M[i]*ciold);
123template<
class value_type>
126 thrust::host_vector<value_type>& x,
127 const thrust::host_vector<value_type>&
y, value_type a = 1.,
130 unsigned size =
y.size();
132 thrust::host_vector<value_type> ci(size), di(size);
133 ci[0] = a*T.P[0]/( a*T.O[0] + d);
134 di[0] =
y[0]/( a*T.O[0] + d);
135 for(
unsigned i=1; i<size; i++)
137 ci[i] = a*T.P[i]/ ( a*T.O[i] + d -a*T.M[i]*ci[i-1]);
138 di[i] = (
y[i]-a*T.M[i]*di[i-1])/(a*T.O[i] + d
141 x[size-1] = di[size-1];
142 for(
int i=size-2; i>=0; i--)
143 x[i] = di[i] - ci[i]*
x[i+1];
157template<
class real_type>
171 m_size = copyable.size();
172 m_alphas.assign(m_size+1,0.);
173 m_betas.assign(m_size+1,0.);
183 m_alphas.assign(m_size+1,0.);
184 m_betas.assign(m_size+1,0.);
193 m_alphas.resize(m_size+1,0.);
194 m_betas.resize(m_size+1,0.);
233 template<
class ContainerType0,
class ContainerType1,
class ContainerType2>
234 void operator()(
const ContainerType0& a,
const ContainerType1& b,
237 unsigned ss = m_size;
247 for(
unsigned i = 2; i<ss+1; i++)
249 m_alphas[i] = a[i-1]*m_alphas[i-1] - c[i-1]*b[i-2]*m_alphas[i-2];
250 if (m_alphas[i] ==0 && i<ss) {
254 if (m_alphas[ss] ==0)
259 m_betas[ss-1]=a[ss-1];
260 m_betas[0] = m_alphas[ss];
261 for(
int i = ss-2; i>0; i--)
263 m_betas[i] = a[i]*m_betas[i+1] - c[i+1]*b[i]*m_betas[i+2];
270 Tinv(0, 0) = 1.0/(a[0]-c[1]*b[0]*m_betas[2]/m_betas[1]);
271 Tinv(ss-1, ss-1) = 1.0/(a[ss-1] -
272 c[ss-1]*b[ss-2]*m_alphas[ss-2]/m_alphas[ss-1]);
273 for(
unsigned i=1; i<ss-1; i++)
276 1.0/(a[i]-c[i]*b[i-1]*m_alphas[i-1]/m_alphas[i]
277 -c[i+1]*b[i]*m_betas[i+2]/m_betas[i+1]);
280 for(
unsigned i=0; i<ss; i++)
282 for(
unsigned j=0; j<ss; j++)
284 Tinv.row_indices[i*ss+j] = j;
285 Tinv.column_indices[i*ss+j] = i;
288 sign(j-i)*std::accumulate(std::next(b.begin(),i),
289 std::next(b.begin(),j), 1.,
290 std::multiplies<value_type>())*
291 m_alphas[i]/m_alphas[j]*Tinv.values[j*ss+j];
296 sign(i-j)*std::accumulate(std::next(c.begin(),j+1),
297 std::next(c.begin(),i+1), 1.,
298 std::multiplies<value_type>())*
299 m_betas[i+1]/m_betas[j+1]*Tinv.values[j*ss+j];
308 if (i%2==0)
return 1;
311 thrust::host_vector<real_type> m_alphas, m_betas;
324template<
class real_type>
338 m_size = copyable.size();
339 m_phi.assign(m_size,0.);
340 m_theta.assign(m_size,0.);
350 m_phi.assign(m_size,0.);
351 m_theta.assign(m_size,0.);
360 m_phi.resize(m_size,0.);
361 m_theta.resize(m_size,0.);
400 template<
class ContainerType0,
class ContainerType1,
class ContainerType2>
401 void operator()(
const ContainerType0& a,
const ContainerType1& b,
407 m_phi[0] = - b[0]/a[0];
408 for(
unsigned i = 1; i<m_size; i++)
410 helper = m_phi[i-1]* c[i] + a[i];
412 else m_phi[i] = -b[i]/helper;
417 if (m_size == 1) m_theta[m_size-1] = 0.0;
420 m_theta[m_size-1] = - c[m_size-1]/a[m_size-1];
421 for(
int i = m_size-2; i>=0; i--)
423 helper = m_theta[i+1]*b[i] + a[i];
425 else m_theta[i] = -c[i]/helper;
430 helper = a[0] + b[0]* m_theta[1];
432 else Tinv(0,0) = 1.0/helper;
434 if (m_size == 1) helper = a[m_size-1];
435 else helper = a[m_size-1] + c[m_size-1]*m_phi[m_size-2];
438 else Tinv( m_size -1 , m_size - 1) = 1.0/helper;
440 for(
unsigned i=1; i<m_size-1; i++)
442 helper = a[i] + c[i]*m_phi[i-1] + b[i]* m_theta[i+1];
444 else Tinv(i,i) = 1.0/helper;
447 for(
unsigned j=0; j<m_size-1; j++)
449 for (
unsigned i=j+1; i<m_size; i++)
451 Tinv(i,j) = m_theta[i]*Tinv(i-1, j);
454 for(
unsigned j=1; j<m_size; j++)
456 for (
int i=j-1; i>=0; i--)
458 Tinv(i,j) = m_phi[i]*Tinv(i+1,j);
463 thrust::host_vector<real_type> m_phi, m_theta;
476template<
class real_type>
490 m_size = copyable.size();
491 m_phi.assign(m_size+1,0.);
492 m_theta.assign(m_size+1,0.);
502 m_phi.assign(m_size+1,0.);
503 m_theta.assign(m_size+1,0.);
512 m_phi.resize(m_size+1,0.);
513 m_theta.resize(m_size+1,0.);
552 template<
class ContainerType0,
class ContainerType1,
class ContainerType2>
553 void operator()(
const ContainerType0& a,
const ContainerType1& b,
558 for(
unsigned i = 0; i<m_size+1; i++)
573 m_theta[i] = a[i-1] * m_theta[i-1] - b[i-2] * c[i-1] * m_theta[i-2];
574 m_phi[is] = a[is] * m_phi[is+1] - b[is] * c[is+1] * m_phi[is+2];
579 for(
unsigned i=0; i<m_size; i++)
581 for(
unsigned j=0; j<m_size; j++)
585 std::accumulate(std::next(b.begin(),i),
586 std::next(b.begin(),j), 1.,
587 std::multiplies<value_type>())*sign(i+j) *
588 m_theta[i] * m_phi[j+1]/m_theta[m_size];
592 Tinv(i,j) = m_theta[i] * m_phi[i+1]/m_theta[m_size];
597 std::accumulate(std::next(c.begin(),j+1),
598 std::next(c.begin(),i+1), 1.,
599 std::multiplies<value_type>())*sign(i+j) *
600 m_theta[j] * m_phi[i+1]/m_theta[m_size];
609 if (i%2==0)
return 1;
612 thrust::host_vector<real_type> m_phi, m_theta;
627template<
class value_type>
644template<
class value_type>
664template<
class value_type>
669 thrust::host_vector<value_type> evals( T.O), subdiagonal( T.P), Z, work;
670 lapack::stev(LAPACK_COL_MAJOR,
'N', evals, subdiagonal, Z, work);
673 return std::array<value_type, 2>{EVmin, EVmax};
void resize(unsigned m, T val=T())
USE THIS ONE Compute the inverse of a general tridiagonal matrix. The algorithm does not rely on the ...
Definition tridiaginv.h:326
void resize(unsigned new_size)
Resize inverse tridiagonal matrix and helper vectors.
Definition tridiaginv.h:358
TridiagInvDF(unsigned size)
Construct from size of vector.
Definition tridiaginv.h:347
void operator()(const dg::TriDiagonal< thrust::host_vector< real_type > > &T, dg::SquareMatrix< real_type > &Tinv)
Compute the inverse of a tridiagonal matrix T.
Definition tridiaginv.h:370
dg::SquareMatrix< real_type > operator()(const dg::TriDiagonal< thrust::host_vector< real_type > > &T)
Compute the inverse of a tridiagonal matrix T.
Definition tridiaginv.h:384
TridiagInvDF(const thrust::host_vector< real_type > ©able)
Construct from vector.
Definition tridiaginv.h:336
TridiagInvDF()
Allocate nothing, Call construct method before usage.
Definition tridiaginv.h:330
real_type value_type
Definition tridiaginv.h:328
void operator()(const ContainerType0 &a, const ContainerType1 &b, const ContainerType2 &c, dg::SquareMatrix< real_type > &Tinv)
Compute the inverse of a tridiagonal matrix with diagonal vectors a,b,c.
Definition tridiaginv.h:401
Compute the inverse of a general tridiagonal matrix.
Definition tridiaginv.h:478
void operator()(const dg::TriDiagonal< thrust::host_vector< real_type > > &T, dg::SquareMatrix< real_type > &Tinv)
Compute the inverse of a tridiagonal matrix T.
Definition tridiaginv.h:522
void resize(unsigned new_size)
Resize inverse tridiagonal matrix and helper vectors.
Definition tridiaginv.h:510
real_type value_type
Definition tridiaginv.h:480
TridiagInvD(unsigned size)
Construct from size of vector.
Definition tridiaginv.h:499
void operator()(const ContainerType0 &a, const ContainerType1 &b, const ContainerType2 &c, dg::SquareMatrix< real_type > &Tinv)
Compute the inverse of a tridiagonal matrix with diagonal vectors a,b,c.
Definition tridiaginv.h:553
dg::SquareMatrix< real_type > operator()(const dg::TriDiagonal< thrust::host_vector< real_type > > &T)
Compute the inverse of a tridiagonal matrix T.
Definition tridiaginv.h:536
TridiagInvD(const thrust::host_vector< real_type > ©able)
Construct from vector.
Definition tridiaginv.h:488
TridiagInvD()
Allocate nothing, Call construct method before usage.
Definition tridiaginv.h:482
Compute the inverse of a general tridiagonal matrix.
Definition tridiaginv.h:159
TridiagInvHMGTI(const thrust::host_vector< real_type > ©able)
Construct from vector.
Definition tridiaginv.h:169
TridiagInvHMGTI(unsigned size)
Construct from size of vector.
Definition tridiaginv.h:180
void operator()(const dg::TriDiagonal< thrust::host_vector< real_type > > &T, dg::SquareMatrix< real_type > &Tinv)
Compute the inverse of a tridiagonal matrix T.
Definition tridiaginv.h:203
void operator()(const ContainerType0 &a, const ContainerType1 &b, const ContainerType2 &c, dg::SquareMatrix< real_type > &Tinv)
Compute the inverse of a tridiagonal matrix with diagonal vectors a,b,c.
Definition tridiaginv.h:234
dg::SquareMatrix< real_type > operator()(const dg::TriDiagonal< thrust::host_vector< real_type > > &T)
Compute the inverse of a tridiagonal matrix T.
Definition tridiaginv.h:217
real_type value_type
Definition tridiaginv.h:161
TridiagInvHMGTI()
Allocate nothing, Call construct method before usage.
Definition tridiaginv.h:163
void resize(unsigned new_size)
Resize inverse tridiagonal matrix and helper vectors.
Definition tridiaginv.h:191
OutputType reduce(const ContainerType &x, OutputType zero, BinaryOp binary_op, UnaryOp unary_op=UnaryOp())
typename TensorTraits< std::decay_t< Vector > >::value_type get_value_type
std::array< value_type, 2 > compute_extreme_EV(const dg::TriDiagonal< thrust::host_vector< value_type > > &T)
Compute extreme Eigenvalues of a symmetric tridiangular matrix.
Definition tridiaginv.h:665
void compute_Tinv_y(const dg::TriDiagonal< thrust::host_vector< value_type > > &T, thrust::host_vector< value_type > &x, const thrust::host_vector< value_type > &y, value_type a=1., value_type d=0.)
Computes the value of via Thomas algorithm.
Definition tridiaginv.h:124
value_type compute_Tinv_m1(const dg::TriDiagonal< thrust::host_vector< value_type > > &T, unsigned size)
Computes the value of via a Thomas algorithm.
Definition tridiaginv.h:95
void invert(const dg::TriDiagonal< thrust::host_vector< value_type > > &T, dg::SquareMatrix< value_type > &Tinv)
Invert a tridiagonal matrix.
Definition tridiaginv.h:628
Classes for Krylov space approximations of a Matrix-Vector product.