HomeSort by relevance Sort by last modified time
    Searched defs:Scalar (Results 101 - 125 of 262) sorted by null

1 2 3 45 6 7 8 91011

  /external/eigen/test/
diagonalmatrices.cpp 15 typedef typename MatrixType::Scalar Scalar;
18 typedef Matrix<Scalar, Rows, 1> VectorType;
19 typedef Matrix<Scalar, 1, Cols> RowVectorType;
20 typedef Matrix<Scalar, Rows, Rows> SquareMatrixType;
21 typedef DiagonalMatrix<Scalar, Rows> LeftDiagonalMatrix;
22 typedef DiagonalMatrix<Scalar, Cols> RightDiagonalMatrix;
23 typedef Matrix<Scalar, Rows==Dynamic?Dynamic:2*Rows, Cols==Dynamic?Dynamic:2*Cols> BigMatrix;
eigensolver_selfadjoint.cpp 24 typedef typename MatrixType::Scalar Scalar;
25 typedef typename NumTraits<Scalar>::Real RealScalar;
26 typedef Matrix<Scalar, MatrixType::RowsAtCompileTime, 1> VectorType;
28 typedef typename std::complex<typename NumTraits<typename MatrixType::Scalar>::Real> Complex;
householder.cpp 24 typedef typename MatrixType::Scalar Scalar;
25 typedef typename NumTraits<Scalar>::Real RealScalar;
26 typedef Matrix<Scalar, MatrixType::RowsAtCompileTime, 1> VectorType;
27 typedef Matrix<Scalar, internal::decrement_size<MatrixType::RowsAtCompileTime>::ret, 1> EssentialVectorType;
28 typedef Matrix<Scalar, MatrixType::RowsAtCompileTime, MatrixType::RowsAtCompileTime> SquareMatrixType;
29 typedef Matrix<Scalar, Dynamic, MatrixType::ColsAtCompileTime> HBlockMatrixType;
30 typedef Matrix<Scalar, Dynamic, 1> HCoeffsVectorType;
32 typedef Matrix<Scalar, MatrixType::ColsAtCompileTime, MatrixType::ColsAtCompileTime> RightSquareMatrixType;
33 typedef Matrix<Scalar, MatrixType::RowsAtCompileTime, Dynamic> VBlockMatrixType
    [all...]
integer_types.cpp 22 typedef typename MatrixType::Scalar Scalar;
24 enum { is_signed = (Scalar(-1) > Scalar(0)) ? 0 : 1 };
40 Scalar s1;
42 s1 = internal::random<Scalar>();
53 typedef typename MatrixType::Scalar Scalar;
55 VERIFY(NumTraits<Scalar>::IsInteger);
56 enum { is_signed = (Scalar(-1) > Scalar(0)) ? 0 : 1 }
    [all...]
lu.cpp 17 typedef typename MatrixType::Scalar Scalar;
47 typedef Matrix<typename MatrixType::Scalar, ColsAtCompileTime, ColsAtCompileTime>
49 typedef Matrix<typename MatrixType::Scalar, RowsAtCompileTime, RowsAtCompileTime>
103 typedef typename MatrixType::Scalar Scalar;
104 typedef typename NumTraits<typename MatrixType::Scalar>::Real RealScalar;
135 typedef typename MatrixType::Scalar Scalar;
136 typedef typename NumTraits<typename MatrixType::Scalar>::Real RealScalar
    [all...]
permutationmatrices.cpp 16 typedef typename MatrixType::Scalar Scalar;
43 Matrix<Scalar,Rows,Rows> lm(lp);
44 Matrix<Scalar,Cols,Cols> rm(rp);
59 Matrix<Scalar,Rows,Rows> lm2(lp2);
60 VERIFY_IS_APPROX((lp*lp2).toDenseMatrix().template cast<Scalar>(), lm*lm2);
61 VERIFY_IS_APPROX((lv.asPermutation()*lv2.asPermutation()).toDenseMatrix().template cast<Scalar>(), lm*lm2);
62 VERIFY_IS_APPROX((MapLeftPerm(lv.data(),lv.size())*MapLeftPerm(lv2.data(),lv2.size())).toDenseMatrix().template cast<Scalar>(), lm*lm2);
94 VERIFY_IS_APPROX(lm, lp2.toDenseMatrix().template cast<Scalar>());
102 VERIFY_IS_APPROX(rm, rp2.toDenseMatrix().template cast<Scalar>());
    [all...]
product.h 26 typedef typename MatrixType::Scalar Scalar;
27 typedef typename NumTraits<Scalar>::NonInteger NonInteger;
28 typedef Matrix<Scalar, MatrixType::RowsAtCompileTime, 1> RowVectorType;
29 typedef Matrix<Scalar, MatrixType::ColsAtCompileTime, 1> ColVectorType;
30 typedef Matrix<Scalar, MatrixType::RowsAtCompileTime, MatrixType::RowsAtCompileTime> RowSquareMatrixType;
31 typedef Matrix<Scalar, MatrixType::ColsAtCompileTime, MatrixType::ColsAtCompileTime> ColSquareMatrixType;
32 typedef Matrix<Scalar, MatrixType::RowsAtCompileTime, MatrixType::ColsAtCompileTime,
54 Scalar s1 = internal::random<Scalar>();
    [all...]
product_notemporary.cpp 34 typedef typename MatrixType::Scalar Scalar;
36 typedef Matrix<Scalar, 1, Dynamic> RowVectorType;
37 typedef Matrix<Scalar, Dynamic, 1> ColVectorType;
38 typedef Matrix<Scalar, Dynamic, Dynamic, ColMajor> ColMajorMatrixType;
39 typedef Matrix<Scalar, Dynamic, Dynamic, RowMajor> RowMajorMatrixType;
51 Scalar s1 = internal::random<Scalar>(),
52 s2 = internal::random<Scalar>(),
53 s3 = internal::random<Scalar>();
    [all...]
product_selfadjoint.cpp 15 typedef typename MatrixType::Scalar Scalar;
16 typedef typename NumTraits<Scalar>::Real RealScalar;
17 typedef Matrix<Scalar, MatrixType::RowsAtCompileTime, 1> VectorType;
18 typedef Matrix<Scalar, 1, MatrixType::RowsAtCompileTime> RowVectorType;
20 typedef Matrix<Scalar, MatrixType::RowsAtCompileTime, Dynamic, RowMajor> RhsMatrixType;
35 Scalar s1 = internal::random<Scalar>(),
36 s2 = internal::random<Scalar>(),
37 s3 = internal::random<Scalar>();
    [all...]
qr.cpp 20 typedef typename MatrixType::Scalar Scalar;
21 typedef Matrix<Scalar, MatrixType::RowsAtCompileTime, MatrixType::RowsAtCompileTime> MatrixQType;
22 typedef Matrix<Scalar, MatrixType::ColsAtCompileTime, 1> VectorType;
37 typedef typename MatrixType::Scalar Scalar;
38 Matrix<Scalar,Rows,Cols> m1 = Matrix<Scalar,Rows,Cols>::Random();
39 HouseholderQR<Matrix<Scalar,Rows,Cols> > qr(m1);
41 Matrix<Scalar,Rows,Cols> r = qr.matrixQR()
    [all...]
qr_colpivoting.cpp 21 typedef typename MatrixType::Scalar Scalar;
23 typedef Matrix<Scalar, MatrixType::RowsAtCompileTime, MatrixType::RowsAtCompileTime> MatrixQType;
24 typedef Matrix<Scalar, MatrixType::ColsAtCompileTime, 1> VectorType;
51 typedef typename MatrixType::Scalar Scalar;
53 Matrix<Scalar,Rows,Cols> m1;
55 ColPivHouseholderQR<Matrix<Scalar,Rows,Cols> > qr(m1);
62 Matrix<Scalar,Rows,Cols> r = qr.matrixQR().template triangularView<Upper>();
63 Matrix<Scalar,Rows,Cols> c = qr.householderQ() * r * qr.colsPermutation().inverse()
    [all...]
qr_fullpivoting.cpp 21 typedef typename MatrixType::Scalar Scalar;
22 typedef Matrix<Scalar, MatrixType::RowsAtCompileTime, MatrixType::RowsAtCompileTime> MatrixQType;
23 typedef Matrix<Scalar, MatrixType::ColsAtCompileTime, 1> VectorType;
39 for(int i = 0; i < rows; i++) for(int j = 0; j < cols; j++) if(i>j) r(i,j) = Scalar(0);
54 typedef typename NumTraits<typename MatrixType::Scalar>::Real RealScalar;
55 typedef typename MatrixType::Scalar Scalar;
80 for(int i = 0; i < size; i++) m1(i,i) = internal::random<Scalar>();
triangular.cpp 16 typedef typename MatrixType::Scalar Scalar;
17 typedef typename NumTraits<Scalar>::Real RealScalar;
18 typedef Matrix<Scalar, MatrixType::RowsAtCompileTime, 1> VectorType;
68 while (internal::abs2(m1(i,i))<1e-1) m1(i,i) = internal::random<Scalar>();
123 typedef typename MatrixType::Scalar Scalar;
124 typedef typename NumTraits<Scalar>::Real RealScalar;
126 typedef Matrix<Scalar, Rows, 1> VectorType;
127 typedef Matrix<Scalar, Rows, Rows> RMatrixType
    [all...]
umeyama.cpp 24 typedef T Scalar;
25 typedef typename NumTraits<Scalar>::Real RealScalar;
27 typedef Eigen::Matrix<Scalar, Eigen::Dynamic, Eigen::Dynamic> MatrixType;
79 typedef T Scalar;
80 typedef typename NumTraits<Scalar>::Real RealScalar;
82 typedef Eigen::Matrix<Scalar, Eigen::Dynamic, Eigen::Dynamic> MatrixType;
85 MatrixType Q = randMatrixUnitary<Scalar>(size);
96 typedef typename internal::traits<MatrixType>::Scalar Scalar;
97 typedef Matrix<Scalar, Eigen::Dynamic, Eigen::Dynamic> MatrixX
    [all...]
visitor.cpp 14 typedef typename MatrixType::Scalar Scalar;
26 m(i) = internal::random<Scalar>();
28 Scalar minc = Scalar(1000), maxc = Scalar(-1000);
47 Scalar eigen_minc, eigen_maxc;
62 typedef typename VectorType::Scalar Scalar;
73 v(i) = internal::random<Scalar>();
    [all...]
  /external/eigen/test/eigen2/
eigen2_adjoint.cpp 18 typedef typename MatrixType::Scalar Scalar;
19 typedef typename NumTraits<Scalar>::Real RealScalar;
20 typedef Matrix<Scalar, MatrixType::RowsAtCompileTime, 1> VectorType;
21 typedef Matrix<Scalar, MatrixType::RowsAtCompileTime, MatrixType::RowsAtCompileTime> SquareMatrixType;
40 Scalar s1 = ei_random<Scalar>(),
41 s2 = ei_random<Scalar>();
52 typedef typename NumTraits<Scalar>::Real RealScalar;
57 if(NumTraits<Scalar>::HasFloatingPoint
    [all...]
eigen2_cholesky.cpp 27 typedef typename MatrixType::Scalar Scalar;
28 typedef typename NumTraits<Scalar>::Real RealScalar;
29 typedef Matrix<Scalar, MatrixType::RowsAtCompileTime, MatrixType::RowsAtCompileTime> SquareMatrixType;
30 typedef Matrix<Scalar, MatrixType::RowsAtCompileTime, 1> VectorType;
43 typedef GslTraits<Scalar> Gsl;
eigen2_cwiseop.cpp 17 template<typename Scalar> struct AddIfNull {
18 const Scalar operator() (const Scalar a, const Scalar b) const {return a<=1e-3 ? b : a;}
19 enum { Cost = NumTraits<Scalar>::AddCost };
24 typedef typename MatrixType::Scalar Scalar;
25 typedef typename NumTraits<Scalar>::Real RealScalar;
26 typedef Matrix<Scalar, MatrixType::RowsAtCompileTime, 1> VectorType;
37 identity = Matrix<Scalar, MatrixType::RowsAtCompileTime, MatrixType::RowsAtCompileTime
    [all...]
eigen2_eigensolver.cpp 25 typedef typename MatrixType::Scalar Scalar;
26 typedef typename NumTraits<Scalar>::Real RealScalar;
27 typedef Matrix<Scalar, MatrixType::RowsAtCompileTime, 1> VectorType;
29 typedef typename std::complex<typename NumTraits<typename MatrixType::Scalar>::Real> Complex;
48 typedef GslTraits<Scalar> Gsl;
108 typedef typename MatrixType::Scalar Scalar;
109 typedef typename NumTraits<Scalar>::Real RealScalar;
110 typedef Matrix<Scalar, MatrixType::RowsAtCompileTime, 1> VectorType
    [all...]
eigen2_sparse_product.cpp 16 typedef typename SparseMatrixType::Scalar Scalar;
20 typedef Matrix<Scalar,Dynamic,Dynamic> DenseMatrix;
21 typedef Matrix<Scalar,Dynamic,1> DenseVector;
32 initSparse<Scalar>(density, refMat2, m2);
33 initSparse<Scalar>(density, refMat3, m3);
34 initSparse<Scalar>(density, refMat4, m4);
63 initSparse<Scalar>(density, refM2, m2);
64 initSparse<Scalar>(density, refM3, m3);
83 initSparse<Scalar>(density, refUp, mUp, ForceRealDiag|/*ForceNonZeroDiag|*/MakeUpperTriangular)
    [all...]
eigen2_triangular.cpp 14 typedef typename MatrixType::Scalar Scalar;
15 typedef typename NumTraits<Scalar>::Real RealScalar;
16 typedef Matrix<Scalar, MatrixType::RowsAtCompileTime, 1> VectorType;
31 identity = Matrix<Scalar, MatrixType::RowsAtCompileTime, MatrixType::RowsAtCompileTime>
33 square = Matrix<Scalar, MatrixType::RowsAtCompileTime, MatrixType::RowsAtCompileTime>
73 while (ei_abs2(m1(i,i))<1e-3) m1(i,i) = ei_random<Scalar>();
eigen2_visitor.cpp 14 typedef typename MatrixType::Scalar Scalar;
25 m(i) = ei_random<Scalar>();
27 Scalar minc = Scalar(1000), maxc = Scalar(-1000);
46 Scalar eigen_minc, eigen_maxc;
61 typedef typename VectorType::Scalar Scalar;
71 v(i) = ei_random<Scalar>();
    [all...]
product.h 27 typedef typename MatrixType::Scalar Scalar;
28 typedef typename NumTraits<Scalar>::FloatingPoint FloatingPoint;
29 typedef Matrix<Scalar, MatrixType::RowsAtCompileTime, 1> RowVectorType;
30 typedef Matrix<Scalar, MatrixType::ColsAtCompileTime, 1> ColVectorType;
31 typedef Matrix<Scalar, MatrixType::RowsAtCompileTime, MatrixType::RowsAtCompileTime> RowSquareMatrixType;
32 typedef Matrix<Scalar, MatrixType::ColsAtCompileTime, MatrixType::ColsAtCompileTime> ColSquareMatrixType;
33 typedef Matrix<Scalar, MatrixType::RowsAtCompileTime, MatrixType::ColsAtCompileTime,
58 Scalar s1 = ei_random<Scalar>();
    [all...]
  /external/eigen/unsupported/Eigen/src/AutoDiff/
AutoDiffVector.h 16 * \brief A scalar type replacement with automatic differentation capability
20 * This class represents a scalar value while tracking its respective derivatives.
27 * AutoDiffScalar can be used as the scalar type of an Eigen::Matrix object. However,
36 //typedef typename internal::traits<ValueType>::Scalar Scalar;
37 typedef typename internal::traits<ValueType>::Scalar BaseScalar;
39 typedef ActiveScalar Scalar;
64 Scalar sum() const { /*std::cerr << "sum \n\n";*/ /*std::cerr << m_jacobian.rowwise().sum() << "\n\n";*/ return Scalar(m_values.sum(), m_jacobian.rowwise().sum()); }
125 typename MakeCwiseBinaryOp<internal::scalar_difference_op<Scalar>,ValueType,OtherValueType>::Type
    [all...]
  /external/eigen/unsupported/Eigen/src/FFT/
ei_fftw_impl.h 179 typedef _Scalar Scalar;
180 typedef std::complex<Scalar> Complex;
197 void fwd( Complex * dst,const Scalar * src,int nfft)
216 // half-complex to scalar
218 void inv( Scalar * dst,const Complex * src,int nfft)
232 typedef fftw_plan<Scalar> PlanData;

Completed in 252 milliseconds

1 2 3 45 6 7 8 91011