Searched defs:Scalar (Results 176 - 200 of 306) sorted by path

1234567891011>>

/external/eigen/test/eigen2/
H A Deigen2_qr.cpp21 typedef typename MatrixType::Scalar Scalar; typedef
22 typedef Matrix<Scalar, MatrixType::ColsAtCompileTime, MatrixType::ColsAtCompileTime> SquareMatrixType;
23 typedef Matrix<Scalar, MatrixType::ColsAtCompileTime, 1> VectorType;
H A Deigen2_regression.cpp18 typename VectorType::Scalar noiseAmplitude)
20 typedef typename VectorType::Scalar Scalar; typedef
27 hyperplane->coeffs().coeffRef(j) = ei_random<Scalar>();
39 Scalar x = - (hyperplane->coeffs().start(size).cwise()*cur_point).sum();
54 typename VectorType::Scalar tolerance)
60 typename VectorType::Scalar error = (result - original).norm() / original.norm();
69 typename VectorType::Scalar tolerance)
75 typename VectorType::Scalar error = (result.coeffs() - original.coeffs()).norm() / original.coeffs().norm();
H A Deigen2_sizeof.cpp14 typedef typename MatrixType::Scalar Scalar; typedef
16 VERIFY(sizeof(MatrixType)==sizeof(Scalar)*MatrixType::SizeAtCompileTime);
18 VERIFY(sizeof(MatrixType)==sizeof(Scalar*) + 2 * sizeof(typename MatrixType::Index));
H A Deigen2_sparse_basic.cpp12 template<typename SetterType,typename DenseType, typename Scalar, int Options>
13 bool test_random_setter(SparseMatrix<Scalar,Options>& sm, const DenseType& ref, const std::vector<Vector2i>& nonzeroCoords)
15 typedef SparseMatrix<Scalar,Options> SparseType;
50 typedef typename SparseMatrixType::Scalar Scalar; typedef
54 typedef Matrix<Scalar,Dynamic,Dynamic> DenseMatrix;
55 typedef Matrix<Scalar,Dynamic,1> DenseVector;
56 Scalar eps = 1e-6;
61 Scalar s1 = ei_random<Scalar>();
[all...]
H A Deigen2_sparse_product.cpp16 typedef typename SparseMatrixType::Scalar Scalar; typedef
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>(densit
[all...]
H A Deigen2_submatrices.cpp16 template<typename Scalar, int _Rows, int _Cols> struct CheckMinor
18 typedef Matrix<Scalar, _Rows, _Cols> MatrixType;
24 Matrix<Scalar, Dynamic, Dynamic> mi = m1.minor(0,0).eval();
33 template<typename Scalar> struct CheckMinor<Scalar,1,1>
35 typedef Matrix<Scalar, 1, 1> MatrixType;
44 typedef typename MatrixType::Scalar Scalar; typedef
46 typedef Matrix<Scalar, MatrixType::RowsAtCompileTime, 1> VectorType;
47 typedef Matrix<Scalar,
[all...]
H A Deigen2_sum.cpp14 typedef typename MatrixType::Scalar Scalar; typedef
21 VERIFY_IS_MUCH_SMALLER_THAN(MatrixType::Zero(rows, cols).sum(), Scalar(1));
22 VERIFY_IS_APPROX(MatrixType::Ones(rows, cols).sum(), Scalar(float(rows*cols))); // the float() here to shut up excessive MSVC warning about int->complex conversion being lossy
23 Scalar x = Scalar(0);
30 typedef typename VectorType::Scalar Scalar; typedef
36 Scalar s = Scalar(
[all...]
H A Deigen2_svd.cpp21 typedef typename MatrixType::Scalar Scalar; typedef
22 typedef typename NumTraits<Scalar>::Real RealScalar;
24 Matrix<Scalar, MatrixType::RowsAtCompileTime, 1> b =
25 Matrix<Scalar, MatrixType::RowsAtCompileTime, 1>::Random(rows,1);
26 Matrix<Scalar, MatrixType::ColsAtCompileTime, 1> x(cols,1), x2(cols,1);
H A Deigen2_swap.cpp28 typedef typename MatrixType::Scalar Scalar; typedef
36 MatrixType m2 = MatrixType::Random(rows,cols) + Scalar(100) * MatrixType::Identity(rows,cols);
37 OtherMatrixType m3 = OtherMatrixType::Random(rows,cols) + Scalar(200) * OtherMatrixType::Identity(rows,cols);
H A Deigen2_triangular.cpp14 typedef typename MatrixType::Scalar Scalar; typedef
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>();
H A Deigen2_visitor.cpp14 typedef typename MatrixType::Scalar Scalar; typedef
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; typedef
71 v(i) = ei_random<Scalar>();
[all...]
H A Dproduct.h27 typedef typename MatrixType::Scalar Scalar; typedef
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/test/
H A Deigen2support.cpp17 typedef typename MatrixType::Scalar Scalar; typedef
25 Scalar s1 = internal::random<Scalar>(),
26 s2 = internal::random<Scalar>();
31 VERIFY_IS_APPROX((m1*Scalar(2)).cwise() - s2, (m1+m1) - MatrixType::Constant(rows,cols,s2) );
H A Deigensolver_complex.cpp21 typedef typename NumTraits<typename VectorType::Scalar>::Real RealScalar;
42 typedef typename MatrixType::Scalar Scalar; typedef
43 typedef typename NumTraits<Scalar>::Real RealScalar;
H A Deigensolver_generalized_real.cpp23 typedef typename MatrixType::Scalar Scalar; typedef
24 typedef Matrix<Scalar, MatrixType::RowsAtCompileTime, 1> VectorType;
H A Deigensolver_generic.cpp24 typedef typename MatrixType::Scalar Scalar; typedef
25 typedef typename NumTraits<Scalar>::Real RealScalar;
27 typedef typename std::complex<typename NumTraits<typename MatrixType::Scalar>::Real> Complex;
H A Deigensolver_selfadjoint.cpp24 typedef typename MatrixType::Scalar Scalar; typedef
25 typedef typename NumTraits<Scalar>::Real RealScalar;
H A Dgeo_alignedbox.cpp28 typedef typename BoxType::Scalar Scalar; typedef
29 typedef typename NumTraits<Scalar>::Real RealScalar;
30 typedef Matrix<Scalar, BoxType::AmbientDimAtCompileTime, 1> VectorType;
50 VERIFY(b0.contains(p0*s1+(Scalar(1)-s1)*p1));
81 typedef typename BoxType::Scalar Scalar; typedef
82 typedef Matrix<Scalar, BoxType::AmbientDimAtCompileTime, 1> VectorType;
95 typedef typename GetDifferentType<Scalar>::type OtherScalar;
97 VERIFY_IS_APPROX(hp1f.template cast<Scalar>(),b
[all...]
H A Dgeo_hyperplane.cpp24 typedef typename HyperplaneType::Scalar Scalar; typedef
25 typedef Matrix<Scalar, HyperplaneType::AmbientDimAtCompileTime, 1> VectorType;
26 typedef Matrix<Scalar, HyperplaneType::AmbientDimAtCompileTime,
39 Scalar s0 = internal::random<Scalar>();
40 Scalar s1 = internal::random<Scalar>();
42 VERIFY_IS_APPROX( n1.dot(n1), Scalar(1) );
44 VERIFY_IS_MUCH_SMALLER_THAN( pl0.absDistance(p0), Scalar(
[all...]
H A Dgeo_parametrizedline.cpp24 typedef typename LineType::Scalar Scalar; typedef
25 typedef typename NumTraits<Scalar>::Real RealScalar;
26 typedef Matrix<Scalar, LineType::AmbientDimAtCompileTime, 1> VectorType;
27 typedef Hyperplane<Scalar,LineType::AmbientDimAtCompileTime> HyperplaneType;
36 Scalar s0 = internal::random<Scalar>();
37 Scalar s1 = abs(internal::random<Scalar>());
43 VERIFY_IS_APPROX( Scalar(l
[all...]
H A Dgeo_quaternion.cpp27 typedef typename QuatType::Scalar Scalar; typedef
28 typedef AngleAxis<Scalar> AA;
30 Scalar largeEps = test_precision<Scalar>();
32 Scalar theta_tot = AA(q1*q0.inverse()).angle();
34 theta_tot = Scalar(2.*M_PI)-theta_tot;
35 for(Scalar t=0; t<=Scalar(1.001); t+=Scalar(0.
[all...]
H A Dhouseholder.cpp24 typedef typename MatrixType::Scalar Scalar; typedef
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::RowsAtCompileTime> TMatrixType;
34 Matrix<Scalar, EIGEN_SIZE_MA
[all...]
H A Dinteger_types.cpp22 typedef typename MatrixType::Scalar Scalar; typedef
24 enum { is_signed = (Scalar(-1) > Scalar(0)) ? 0 : 1 };
40 Scalar s1;
42 s1 = internal::random<Scalar>();
53 typedef typename MatrixType::Scalar Scalar; typedef
55 VERIFY(NumTraits<Scalar>::IsInteger);
56 enum { is_signed = (Scalar(
[all...]
H A Dinverse.cpp24 typedef typename MatrixType::Scalar Scalar; typedef
33 VERIFY_IS_APPROX((Scalar(2)*m2).inverse(), m2.inverse()*Scalar(0.5));
44 typedef typename NumTraits<Scalar>::Real RealScalar;
45 typedef Matrix<Scalar, MatrixType::ColsAtCompileTime, 1> VectorType;
H A Djacobisvd.cpp29 typedef typename MatrixType::Scalar Scalar; typedef
30 typedef Matrix<Scalar, RowsAtCompileTime, RowsAtCompileTime> MatrixUType;
31 typedef Matrix<Scalar, ColsAtCompileTime, ColsAtCompileTime> MatrixVType;
34 sigma.diagonal() = svd.singularValues().template cast<Scalar>();
69 typedef typename MatrixType::Scalar Scalar; typedef
80 typedef Matrix<Scalar, RowsAtCompileTime, Dynamic> RhsType;
81 typedef Matrix<Scalar, ColsAtCompileTime, Dynamic> SolutionType;
124 typedef Matrix<Scalar, RankAtCompileTime
[all...]

Completed in 348 milliseconds

1234567891011>>