Home
last modified time | relevance | path

Searched refs:complex_t (Results 1 – 25 of 616) sorted by relevance

12345678910>>...25

/dports/math/xlife++/xlifepp-sources-v2.0.1-2018-05-09/src/utils/
H A DcomplexUtils.hpp37 complex_t asin(const complex_t&);
38 complex_t acos(const complex_t&);
39 complex_t atan(const complex_t&);
40 complex_t asinh(const complex_t&);
41 complex_t acosh(const complex_t&);
42 complex_t atanh(const complex_t&);
43 complex_t cbrt(const complex_t&);
85 complex_t tran(const complex_t&);
87 complex_t adj(const complex_t&);
89 complex_t diag(const complex_t&);
[all …]
H A DcomplexUtils.cpp33 complex_t asin(const complex_t& z) in asin()
38 complex_t acos(const complex_t& z) in acos()
43 complex_t atan(const complex_t& z) in atan()
48 complex_t asinh(const complex_t& z) in asinh()
70 complex_t acosh(const complex_t& z) in acosh()
126 complex_t atanh(const complex_t& z) in atanh()
162 complex_t cbrt(const complex_t& z) in cbrt()
195 complex_t operator+(const int i, const complex_t& z) in operator +()
207 complex_t operator+(const complex_t& z, const int i) in operator +()
220 complex_t operator-(const int i, const complex_t& z) in operator -()
[all …]
H A DVector.cpp77 Vector<complex_t>& Vector<complex_t>::operator=(const Vector<real_t>& x) in operator =()
433 Vector<Vector<complex_t> > operator*(const complex_t& x, const Vector<Vector<complex_t> >& A) in operator *()
440 Vector<Vector<complex_t> > operator*(const Vector<Vector<complex_t> >& A, const complex_t& x) in operator *()
447 Vector<Vector<complex_t> > operator/(const Vector<Vector<complex_t> >& A, const complex_t& x) in operator /()
489 complex_t z(0.); in dotRC()
502 complex_t z(0.); in dotC()
512 complex_t z(0.); in dotC()
513 complex_t zero(0.); in dotC()
524 complex_t dot(const Vector<complex_t>& u, const Vector<real_t>& v) in dot()
531 complex_t dot(const Vector<real_t>& u, const Vector<complex_t>& v) in dot()
[all …]
H A DMatrix.cpp41 Matrix<complex_t> adjoint(const Matrix<complex_t>& cB) //! adjoint of a complex matrix in adjoint()
45 Matrix<complex_t> r(nbc, nbr, complex_t(0.)); in adjoint()
50 Matrix<complex_t> adj(const Matrix<complex_t>& cB) //! adjoint of a complex matrix in adj()
111 Matrix<complex_t> r(rB.vsize(), rB.hsize(), complex_t(0.)); in cmplx()
117 *it_r = complex_t(*it_rB); in cmplx()
123 Matrix<complex_t> conj(const Matrix<complex_t>& cB) //! conjugate a complex matrix in conj()
125 Matrix<complex_t> r(cB.vsize(), cB.hsize(), complex_t(0.)); in conj()
144 Matrix<complex_t> r(cB); in operator +()
163 Matrix<complex_t> r(cA); in operator +()
208 Matrix<complex_t> r(cB); in operator -()
[all …]
H A DTraits.hpp132 struct NumTraits<complex_t>
140 typedef complex_t Scalar;
145 static inline complex_t zero() { return complex_t(0.0, 0.0);} in zero()
146 static inline complex_t one() { return complex_t(1.0, 0.0);} in one()
151 static inline complex_t value(const complex_t& v) { return v;} in value()
160 static inline complex_t squareroot(complex_t x) in squareroot()
172 static inline complex_t conjugate(complex_t a) { return complex_t(a.real(), -a.imag()); } in conjugate()
173 static inline complex_t compare2epsilon(complex_t a) in compare2epsilon()
202 typedef complex_t Type;
213 typedef complex_t Type;
[all …]
/dports/math/xlife++/xlifepp-sources-v2.0.1-2018-05-09/src/mathsResources/specialFunctions/
H A DspecialFunctions.hpp78 complex_t besselJ0(const complex_t z); //!< Bessel function of the first kind and order 0 : J_0(z) …
81 complex_t besselJ1(const complex_t z); //!< Bessel function of the first kind and order 1 : J_1(z) …
90 complex_t besselY0(const complex_t z); //!< Bessel function of the second kind and order 0 : Y_0(z)…
646 complex_t e1z(const complex_t&); //!< return E1(z)
648 complex_t eInz(const complex_t& z); //!< return \f$E1(z) + gamma + log(z) = \sum_{n>0} (-z)^n / n n…
651 complex_t expzE1z(const complex_t&); //!< return exp(z)*E1(z)
653 complex_t zexpzE1z(const complex_t&); //!< return z*exp(z)*E1(z)
898 complex_t gammaFunction(const complex_t&); //!< return \f$\int_0^t dt t^{x-1} \exp(-t)\f$ for x > 0
902 complex_t logGamma1(const complex_t&); //!< return Log(Gamma(z))
903 complex_t logGamma(const complex_t&); //!< Paul Godfrey's Lanczos implementation of the Gamma funct…
[all …]
/dports/lang/gcc9/gcc-9.4.0/gcc/d/dmd/
H A Dcomplex_t.h18 struct complex_t struct
26 complex_t operator + (complex_t y) { return complex_t(re + y.re, im + y.im); }
27 complex_t operator - (complex_t y) { return complex_t(re - y.re, im - y.im); }
28 complex_t operator - () { return complex_t(-re, -im); }
29complex_t operator * (complex_t y) { return complex_t(re * y.re - im * y.im, im * y.re + re * y.im…
31 complex_t operator / (complex_t y)
58 inline complex_t operator * (real_t x, complex_t y) { return complex_t(x) * y; }
59 inline complex_t operator * (complex_t x, real_t y) { return x * complex_t(y); }
60 inline complex_t operator / (complex_t x, real_t y) { return x / complex_t(y); }
63 inline real_t creall(complex_t x) in creall()
[all …]
/dports/devel/avr-gcc/gcc-10.2.0/gcc/d/dmd/
H A Dcomplex_t.h18 struct complex_t struct
26 complex_t operator + (complex_t y) { return complex_t(re + y.re, im + y.im); }
27 complex_t operator - (complex_t y) { return complex_t(re - y.re, im - y.im); }
28 complex_t operator - () { return complex_t(-re, -im); }
29complex_t operator * (complex_t y) { return complex_t(re * y.re - im * y.im, im * y.re + re * y.im…
31 complex_t operator / (complex_t y)
58 inline complex_t operator * (real_t x, complex_t y) { return complex_t(x) * y; }
59 inline complex_t operator * (complex_t x, real_t y) { return x * complex_t(y); }
60 inline complex_t operator / (complex_t x, real_t y) { return x / complex_t(y); }
63 inline real_t creall(complex_t x) in creall()
[all …]
/dports/lang/gcc11-devel/gcc-11-20211009/gcc/d/dmd/
H A Dcomplex_t.h18 struct complex_t struct
26 complex_t operator + (complex_t y) { return complex_t(re + y.re, im + y.im); }
27 complex_t operator - (complex_t y) { return complex_t(re - y.re, im - y.im); }
28 complex_t operator - () { return complex_t(-re, -im); }
29complex_t operator * (complex_t y) { return complex_t(re * y.re - im * y.im, im * y.re + re * y.im…
31 complex_t operator / (complex_t y)
58 inline complex_t operator * (real_t x, complex_t y) { return complex_t(x) * y; }
59 inline complex_t operator * (complex_t x, real_t y) { return x * complex_t(y); }
60 inline complex_t operator / (complex_t x, real_t y) { return x / complex_t(y); }
63 inline real_t creall(complex_t x) in creall()
[all …]
/dports/misc/cxx_atomics_pic/gcc-11.2.0/gcc/d/dmd/
H A Dcomplex_t.h18 struct complex_t struct
26 complex_t operator + (complex_t y) { return complex_t(re + y.re, im + y.im); }
27 complex_t operator - (complex_t y) { return complex_t(re - y.re, im - y.im); }
28 complex_t operator - () { return complex_t(-re, -im); }
29complex_t operator * (complex_t y) { return complex_t(re * y.re - im * y.im, im * y.re + re * y.im…
31 complex_t operator / (complex_t y)
58 inline complex_t operator * (real_t x, complex_t y) { return complex_t(x) * y; }
59 inline complex_t operator * (complex_t x, real_t y) { return x * complex_t(y); }
60 inline complex_t operator / (complex_t x, real_t y) { return x / complex_t(y); }
63 inline real_t creall(complex_t x) in creall()
[all …]
/dports/lang/gcc9-aux/gcc-9.1.0/gcc/d/dmd/
H A Dcomplex_t.h18 struct complex_t struct
26 complex_t operator + (complex_t y) { return complex_t(re + y.re, im + y.im); }
27 complex_t operator - (complex_t y) { return complex_t(re - y.re, im - y.im); }
28 complex_t operator - () { return complex_t(-re, -im); }
29complex_t operator * (complex_t y) { return complex_t(re * y.re - im * y.im, im * y.re + re * y.im…
31 complex_t operator / (complex_t y)
58 inline complex_t operator * (real_t x, complex_t y) { return complex_t(x) * y; }
59 inline complex_t operator * (complex_t x, real_t y) { return x * complex_t(y); }
60 inline complex_t operator / (complex_t x, real_t y) { return x / complex_t(y); }
63 inline real_t creall(complex_t x) in creall()
[all …]
/dports/lang/gcc10/gcc-10.3.0/gcc/d/dmd/
H A Dcomplex_t.h18 struct complex_t struct
26 complex_t operator + (complex_t y) { return complex_t(re + y.re, im + y.im); }
27 complex_t operator - (complex_t y) { return complex_t(re - y.re, im - y.im); }
28 complex_t operator - () { return complex_t(-re, -im); }
29complex_t operator * (complex_t y) { return complex_t(re * y.re - im * y.im, im * y.re + re * y.im…
31 complex_t operator / (complex_t y)
58 inline complex_t operator * (real_t x, complex_t y) { return complex_t(x) * y; }
59 inline complex_t operator * (complex_t x, real_t y) { return x * complex_t(y); }
60 inline complex_t operator / (complex_t x, real_t y) { return x / complex_t(y); }
63 inline real_t creall(complex_t x) in creall()
[all …]
/dports/lang/gcc9-devel/gcc-9-20211007/gcc/d/dmd/
H A Dcomplex_t.h18 struct complex_t struct
26 complex_t operator + (complex_t y) { return complex_t(re + y.re, im + y.im); }
27 complex_t operator - (complex_t y) { return complex_t(re - y.re, im - y.im); }
28 complex_t operator - () { return complex_t(-re, -im); }
29complex_t operator * (complex_t y) { return complex_t(re * y.re - im * y.im, im * y.re + re * y.im…
31 complex_t operator / (complex_t y)
58 inline complex_t operator * (real_t x, complex_t y) { return complex_t(x) * y; }
59 inline complex_t operator * (complex_t x, real_t y) { return x * complex_t(y); }
60 inline complex_t operator / (complex_t x, real_t y) { return x / complex_t(y); }
63 inline real_t creall(complex_t x) in creall()
[all …]
/dports/lang/gcc11/gcc-11.2.0/gcc/d/dmd/
H A Dcomplex_t.h18 struct complex_t struct
26 complex_t operator + (complex_t y) { return complex_t(re + y.re, im + y.im); }
27 complex_t operator - (complex_t y) { return complex_t(re - y.re, im - y.im); }
28 complex_t operator - () { return complex_t(-re, -im); }
29complex_t operator * (complex_t y) { return complex_t(re * y.re - im * y.im, im * y.re + re * y.im…
31 complex_t operator / (complex_t y)
58 inline complex_t operator * (real_t x, complex_t y) { return complex_t(x) * y; }
59 inline complex_t operator * (complex_t x, real_t y) { return x * complex_t(y); }
60 inline complex_t operator / (complex_t x, real_t y) { return x / complex_t(y); }
63 inline real_t creall(complex_t x) in creall()
[all …]
/dports/lang/gcc10-devel/gcc-10-20211008/gcc/d/dmd/
H A Dcomplex_t.h18 struct complex_t struct
26 complex_t operator + (complex_t y) { return complex_t(re + y.re, im + y.im); }
27 complex_t operator - (complex_t y) { return complex_t(re - y.re, im - y.im); }
28 complex_t operator - () { return complex_t(-re, -im); }
29complex_t operator * (complex_t y) { return complex_t(re * y.re - im * y.im, im * y.re + re * y.im…
31 complex_t operator / (complex_t y)
58 inline complex_t operator * (real_t x, complex_t y) { return complex_t(x) * y; }
59 inline complex_t operator * (complex_t x, real_t y) { return x * complex_t(y); }
60 inline complex_t operator / (complex_t x, real_t y) { return x / complex_t(y); }
63 inline real_t creall(complex_t x) in creall()
[all …]
/dports/lang/gcc12-devel/gcc-12-20211205/gcc/d/dmd/
H A Dcomplex_t.h18 struct complex_t struct
26 complex_t operator + (complex_t y) { return complex_t(re + y.re, im + y.im); }
27 complex_t operator - (complex_t y) { return complex_t(re - y.re, im - y.im); }
28 complex_t operator - () { return complex_t(-re, -im); }
29complex_t operator * (complex_t y) { return complex_t(re * y.re - im * y.im, im * y.re + re * y.im…
31 complex_t operator / (complex_t y)
58 inline complex_t operator * (real_t x, complex_t y) { return complex_t(x) * y; }
59 inline complex_t operator * (complex_t x, real_t y) { return x * complex_t(y); }
60 inline complex_t operator / (complex_t x, real_t y) { return x / complex_t(y); }
63 inline real_t creall(complex_t x) in creall()
[all …]
/dports/math/xlife++/xlifepp-sources-v2.0.1-2018-05-09/src/largeMatrix/
H A DLargeMatrix.cpp44 std::vector<complex_t> res(mat.nbRows, complex_t(0)); in operator *()
61 std::vector<complex_t> res(mat.nbRows, complex_t(0)); in operator *()
83 std::vector<Vector<complex_t> > res(mat.nbRows, Vector<complex_t>(mat.nbRowsSub, 0.)); in operator *()
105 std::vector<Vector<complex_t> > res(mat.nbRows, Vector<complex_t>(mat.nbRowsSub, 0.)); in operator *()
129 std::vector<complex_t> res(mat.nbCols, complex_t(0)); in operator *()
153 std::vector<complex_t> res(mat.nbCols, complex_t(0)); in operator *()
361 LargeMatrix<complex_t> operator*(const LargeMatrix<complex_t>& mat, const real_t v) in operator *()
367 LargeMatrix<complex_t> operator*(const real_t v, const LargeMatrix<complex_t>& mat) in operator *()
382 LargeMatrix<complex_t> result(mat.storage_p, complex_t(0.0), mat.sym); in multMatrixScalar()
391 LargeMatrix<complex_t> operator*(const LargeMatrix<real_t>& mat, const complex_t v) in operator *()
[all …]
H A DMatrixStorage.hpp374 …ual void multMatrixVector(const std::vector<complex_t>&, const std::vector<complex_t>&, std::vecto… in multMatrixVector() argument
383 …virtual void multMatrixVector(const std::vector<complex_t>&, complex_t*, complex_t*, SymType) const in multMatrixVector() argument
407 …ual void multVectorMatrix(const std::vector<complex_t>&, const std::vector<complex_t>&, std::vecto… in multVectorMatrix() argument
416 …virtual void multVectorMatrix(const std::vector<complex_t>&, complex_t*, complex_t*, SymType) const in multVectorMatrix() argument
502 …tual void addMatrixMatrix(const std::vector<complex_t>&, const std::vector<complex_t>&, std::vecto… in addMatrixMatrix() argument
549 …void multMatrixDiagMatrix(const std::vector<complex_t>&, const std::vector<complex_t>&, std::vecto…
564 …void multDiagMatrixMatrix(const std::vector<complex_t>&, const std::vector<complex_t>&, std::vecto…
667 …virtual void lowerD1Solver(const std::vector<complex_t>&, std::vector<complex_t>&, std::vector<com… in lowerD1Solver() argument
679 …virtual void diagonalSolver(const std::vector<complex_t>&, std::vector<complex_t>&, std::vector<co… in diagonalSolver() argument
715 …rtual void lowerD1LeftSolver(const std::vector<complex_t>&, std::vector<complex_t>&, std::vector<c… in lowerD1LeftSolver() argument
[all …]
/dports/audio/libbpm/libbpm-0.3/bpmnr/
H A Dnr_complex.c11 complex_t z; in complex()
23 complex_t c_conj( complex_t z ) { return complex( z.re, -z.im ); } in c_conj()
24 complex_t c_neg( complex_t z ) { return complex( -z.re, -z.im ); } in c_neg()
26 complex_t c_sum( complex_t z1, complex_t z2 ) { return complex( z1.re + z2.re, z1.im + z2.im ); } in c_sum()
27 complex_t c_diff( complex_t z1, complex_t z2 ) { return complex( z1.re - z2.re, z1.im - z2.im ); } in c_diff()
29 complex_t c_mult( complex_t z1, complex_t z2 ) { in c_mult()
34 complex_t c_scale( double r, complex_t z ) { return complex( r*z.re, r*z.im); } in c_scale()
37 complex_t c_div( complex_t z1, complex_t z2 ) { in c_div()
43 complex_t c_sqr( complex_t z ) { return c_mult( z, z ); } in c_sqr()
49 complex_t c_sqrt( complex_t z ) { in c_sqrt()
[all …]
/dports/math/xlife++/xlifepp-sources-v2.0.1-2018-05-09/src/mathsResources/
H A DpolynomialsRoots.cpp64 complex_t alpha0; in ferrari()
67 complex_t beta0; in ferrari()
75 std::vector<complex_t> res1=quadratic(complex_t(1.),alpha0,y0+beta0); in ferrari()
96 complex_t j2=j*j; in cardan()
111 complex_t u=xlifepp::cbrt(-q+complex_t(0.,std::sqrt(delta))); in cardan()
121 std::vector<complex_t> cardan(complex_t a, complex_t b, complex_t c, complex_t d) in cardan()
124 complex_t a2=a*a; in cardan()
125 complex_t a3=a2*a; in cardan()
126 complex_t b2=b*b; in cardan()
133 complex_t j2=j*j; in cardan()
[all …]
/dports/math/xlife++/xlifepp-sources-v2.0.1-2018-05-09/src/largeMatrix/denseStorage/
H A DSymDenseStorage.hpp92 void setDiagValue(std::vector<complex_t>& m, const complex_t k) in setDiagValue()
107 …void addMatrixMatrix(const std::vector<complex_t>& m, const std::vector<complex_t>& v, std::vector… in addMatrixMatrix()
147 …void multMatrixVector(const std::vector<complex_t>& m, const std::vector<complex_t>& v, std::vecto… in multMatrixVector()
171 …void multVectorMatrix(const std::vector<complex_t>& m, const std::vector<complex_t>& v, std::vecto… in multVectorMatrix()
195 …void multMatrixVector(const std::vector<complex_t>& m, complex_t* vp, complex_t* rp, SymType sym) … in multMatrixVector()
207 …void multVectorMatrix(const std::vector<complex_t>& m, complex_t* vp, complex_t* rp, SymType sym) … in multVectorMatrix()
224 …l void lowerMatrixVector(const std::vector<complex_t>&m, const std::vector<complex_t>&v, std::vect… in lowerMatrixVector()
252 …l void upperMatrixVector(const std::vector<complex_t>&m, const std::vector<complex_t>&v, std::vect… in upperMatrixVector()
266 …void upperD1MatrixVector(const std::vector<complex_t>&m, const std::vector<complex_t>&v, std::vect… in upperD1MatrixVector()
309 …void diagonalSolver(const std::vector<complex_t>& m, std::vector<complex_t>& v, std::vector<comple… in diagonalSolver()
[all …]
H A DColDenseStorage.hpp102 void setDiagValue(std::vector<complex_t>& m, const complex_t k) in setDiagValue()
118 …void addMatrixMatrix(const std::vector<complex_t>& m, const std::vector<complex_t>& v, std::vector… in addMatrixMatrix()
163 …void multMatrixVector(const std::vector<complex_t>& m, const std::vector<complex_t>& v, std::vecto… in multMatrixVector()
187 …void multMatrixVector(const std::vector<complex_t>& m, complex_t* vp, complex_t* rp, SymType sym) … in multMatrixVector()
199 …void multVectorMatrix(const std::vector<complex_t>& m, complex_t* vp, complex_t* rp, SymType sym) … in multVectorMatrix()
211 …void multVectorMatrix(const std::vector<complex_t>& m, const std::vector<complex_t>& v, std::vecto… in multVectorMatrix()
244 …l void lowerMatrixVector(const std::vector<complex_t>&m, const std::vector<complex_t>&v, std::vect… in lowerMatrixVector()
257 …oid lowerD1MatrixVector(const std::vector<complex_t>& m, const std::vector<complex_t>& v, std::vec… in lowerD1MatrixVector()
270 …l void upperMatrixVector(const std::vector<complex_t>&m, const std::vector<complex_t>&v, std::vect… in upperMatrixVector()
283 …void upperD1MatrixVector(const std::vector<complex_t>&m, const std::vector<complex_t>&v, std::vect… in upperD1MatrixVector()
[all …]
H A DDualDenseStorage.hpp108 void setDiagValue(std::vector<complex_t>& m, const complex_t k) in setDiagValue()
124 …void addMatrixMatrix(const std::vector<complex_t>& m, const std::vector<complex_t>& v, std::vector… in addMatrixMatrix()
149 …void multMatrixVector(const std::vector<complex_t>& m, const std::vector<complex_t>& v, std::vecto… in multMatrixVector()
173 …void multVectorMatrix(const std::vector<complex_t>& m, const std::vector<complex_t>& v, std::vecto… in multVectorMatrix()
197 …void multMatrixVector(const std::vector<complex_t>& m, complex_t* vp, complex_t* rp, SymType sym) … in multMatrixVector()
209 …void multVectorMatrix(const std::vector<complex_t>& m, complex_t* vp, complex_t* rp, SymType sym) … in multVectorMatrix()
226 …l void lowerMatrixVector(const std::vector<complex_t>&m, const std::vector<complex_t>&v, std::vect… in lowerMatrixVector()
252 …l void upperMatrixVector(const std::vector<complex_t>&m, const std::vector<complex_t>&v, std::vect… in upperMatrixVector()
265 …void upperD1MatrixVector(const std::vector<complex_t>&m, const std::vector<complex_t>&v, std::vect… in upperD1MatrixVector()
374 …void sorDiagonalSolver(const std::vector<complex_t>& m, const std::vector<complex_t>& b, std::vect… in sorDiagonalSolver()
[all …]
/dports/math/xlife++/xlifepp-sources-v2.0.1-2018-05-09/src/mathsResources/greenFunctions/
H A DMaxwell3dKernel.cpp89 complex_t k = pa("k"); in Maxwell3d()
90 complex_t ukk = 1./(k*k); in Maxwell3d()
99 Matrix<complex_t> mIG(3,3); in Maxwell3d()
118 complex_t k = pa("k"); in Maxwell3dCurlx()
122 complex_t ikr = i_ * k * r; in Maxwell3dCurlx()
140 complex_t k = pa("k"); in Maxwell3dCurly()
162 Vector< Vector<complex_t> > curlxyG(3,Vector<complex_t>(3,0.)); in Maxwell3dCurlxy()
163 complex_t k = pa("k"); in Maxwell3dCurlxy()
195 complex_t k = pa("k"); in Maxwell3dDivx()
211 complex_t k = pa("k"); in Maxwell3dDivy()
[all …]
/dports/math/xlife++/xlifepp-sources-v2.0.1-2018-05-09/src/largeMatrix/skylineStorage/
H A DDualSkylineStorage.hpp191 void setDiagValue(std::vector<complex_t>& m, const complex_t k) in setDiagValue()
206 …void addMatrixMatrix(const std::vector<complex_t>& m, const std::vector<complex_t>& v, std::vector… in addMatrixMatrix()
239 …void multMatrixVector(const std::vector<complex_t>& m, const std::vector<complex_t>& v, std::vecto… in multMatrixVector()
263 …void multVectorMatrix(const std::vector<complex_t>& m, const std::vector<complex_t>& v, std::vecto… in multVectorMatrix()
286 …void multMatrixVector(const std::vector<complex_t>& m, complex_t* vp, complex_t* rp, SymType sym) … in multMatrixVector()
298 …void multVectorMatrix(const std::vector<complex_t>& m, complex_t* vp, complex_t* rp, SymType sym) … in multVectorMatrix()
315 …l void lowerMatrixVector(const std::vector<complex_t>&m, const std::vector<complex_t>&v, std::vect… in lowerMatrixVector()
341 …l void upperMatrixVector(const std::vector<complex_t>&m, const std::vector<complex_t>&v, std::vect… in upperMatrixVector()
417 …void lowerD1Solver(const std::vector<complex_t>& m, std::vector<complex_t>& v, std::vector<complex… in lowerD1Solver()
432 …void diagonalSolver(const std::vector<complex_t>& m, std::vector<complex_t>& v, std::vector<comple… in diagonalSolver()
[all …]

12345678910>>...25