HomeSort by relevance Sort by last modified time
    Searched refs:Scalar (Results 351 - 375 of 600) sorted by null

<<11121314151617181920>>

  /external/eigen/unsupported/test/
FFTW.cpp 65 template<int Container, typename Scalar> struct VectorType;
67 template<typename Scalar> struct VectorType<StdVectorContainer,Scalar>
69 typedef vector<Scalar> type;
72 template<typename Scalar> struct VectorType<EigenVectorContainer,Scalar>
74 typedef Matrix<Scalar,Dynamic,1> type;
81 typedef typename FFT<T>::Scalar Scalar;
82 typedef typename VectorType<Container,Scalar>::type ScalarVector
    [all...]
  /external/eigen/Eigen/src/SVD/
JacobiSVD.h 19 bool IsComplex = NumTraits<typename MatrixType::Scalar>::IsComplex>
69 typedef typename MatrixType::Scalar Scalar;
75 typedef Matrix<Scalar, 1, RowsAtCompileTime, RowMajor, 1, MaxRowsAtCompileTime> WorkspaceType;
110 typedef typename MatrixType::Scalar Scalar;
119 typedef Matrix<Scalar, ColsAtCompileTime, RowsAtCompileTime, Options, MaxColsAtCompileTime, MaxRowsAtCompileTime>
201 typedef typename MatrixType::Scalar Scalar;
211 typedef Matrix<Scalar, ColsAtCompileTime, RowsAtCompileTime, Options, MaxColsAtCompileTime, MaxRowsAtCompileTime
    [all...]
  /external/eigen/Eigen/src/Core/products/
GeneralMatrixMatrixTriangular.h 15 template<typename Scalar, typename Index, int StorageOrder, int UpLo, bool ConjLhs, bool ConjRhs>
193 static void run(MatrixType& mat, const ProductType& prod, const typename MatrixType::Scalar& alpha)
195 typedef typename MatrixType::Scalar Scalar;
210 Scalar actualAlpha = alpha * LhsBlasTraits::extractScalarFactor(prod.lhs().derived()) * RhsBlasTraits::extractScalarFactor(prod.rhs().derived());
218 internal::gemv_static_vector_if<Scalar,Lhs::SizeAtCompileTime,Lhs::MaxSizeAtCompileTime,!UseLhsDirectly> static_lhs;
219 ei_declare_aligned_stack_constructed_variable(Scalar, actualLhsPtr, actualLhs.size(),
220 (UseLhsDirectly ? const_cast<Scalar*>(actualLhs.data()) : static_lhs.data()));
223 internal::gemv_static_vector_if<Scalar,Rhs::SizeAtCompileTime,Rhs::MaxSizeAtCompileTime,!UseRhsDirectly> static_rhs;
224 ei_declare_aligned_stack_constructed_variable(Scalar, actualRhsPtr, actualRhs.size()
    [all...]
  /external/eigen/test/
cholesky.cpp 31 typedef typename MatrixType::Scalar Scalar;
33 typedef Matrix<Scalar, MatrixType::RowsAtCompileTime, 1> VectorType;
70 typedef typename MatrixType::Scalar Scalar;
71 typedef typename NumTraits<Scalar>::Real RealScalar;
72 typedef Matrix<Scalar, MatrixType::RowsAtCompileTime, MatrixType::RowsAtCompileTime> SquareMatrixType;
73 typedef Matrix<Scalar, MatrixType::RowsAtCompileTime, 1> VectorType;
204 Matrix<Scalar,Dynamic,Dynamic> a = Matrix<Scalar,Dynamic,Dynamic>::Random(rows,r)
    [all...]
denseLM.cpp 20 template<typename Scalar>
21 struct DenseLM : DenseFunctor<Scalar>
23 typedef DenseFunctor<Scalar> Base;
25 typedef Matrix<Scalar,Dynamic,1> VectorType;
27 DenseLM(int n, int m) : DenseFunctor<Scalar>(n,m)
117 typedef typename VectorType::Scalar Scalar;
product_trsolve.cpp 30 template<typename Scalar,int Size, int Cols> void trsolve(int size=Size,int cols=Cols)
32 typedef typename NumTraits<Scalar>::Real RealScalar;
34 Matrix<Scalar,Size,Size,ColMajor> cmLhs(size,size);
35 Matrix<Scalar,Size,Size,RowMajor> rmLhs(size,size);
39 Matrix<Scalar,Size,Cols,colmajor> cmRhs(size,cols);
40 Matrix<Scalar,Size,Cols,rowmajor> rmRhs(size,cols);
41 Matrix<Scalar,Dynamic,Dynamic,colmajor> ref(size,cols);
product_extra.cpp 15 typedef typename MatrixType::Scalar Scalar;
16 typedef Matrix<Scalar, 1, Dynamic> RowVectorType;
17 typedef Matrix<Scalar, Dynamic, 1> ColVectorType;
18 typedef Matrix<Scalar, Dynamic, Dynamic,
37 Scalar s1 = internal::random<Scalar>(),
38 s2 = internal::random<Scalar>(),
39 s3 = internal::random<Scalar>();
vectorwiseop.cpp 17 typedef typename ArrayType::Scalar Scalar;
18 typedef Array<Scalar, ArrayType::RowsAtCompileTime, 1> ColVectorType;
19 typedef Array<Scalar, 1, ArrayType::ColsAtCompileTime> RowVectorType;
119 typedef typename MatrixType::Scalar Scalar;
120 typedef typename NumTraits<Scalar>::Real RealScalar;
121 typedef Matrix<Scalar, MatrixType::RowsAtCompileTime, 1> ColVectorType;
122 typedef Matrix<Scalar, 1, MatrixType::ColsAtCompileTime> RowVectorType;
  /external/eigen/Eigen/src/Core/
Diagonal.h 94 Scalar,
95 const Scalar
99 inline const Scalar* data() const { return &(m_matrix.const_cast_derived().coeffRef(rowOffset(), colOffset())); }
101 inline Scalar& coeffRef(Index row, Index)
107 inline const Scalar& coeffRef(Index row, Index) const
117 inline Scalar& coeffRef(Index idx)
123 inline const Scalar& coeffRef(Index idx) const
Reverse.h 37 typedef typename MatrixType::Scalar Scalar;
85 PacketSize = internal::packet_traits<Scalar>::size,
110 inline Scalar& operator()(Index row, Index col)
116 inline Scalar& coeffRef(Index row, Index col)
133 inline Scalar& coeffRef(Index index)
138 inline Scalar& operator()(Index index)
SelfAdjointView.h 63 typedef typename internal::traits<SelfAdjointView>::Scalar Scalar;
83 inline Scalar coeff(Index row, Index col) const
92 inline Scalar& coeffRef(Index row, Index col)
132 * \sa rankUpdate(const MatrixBase<DerivedU>&, Scalar)
135 SelfAdjointView& rankUpdate(const MatrixBase<DerivedU>& u, const MatrixBase<DerivedV>& v, const Scalar& alpha = Scalar(1));
145 * \sa rankUpdate(const MatrixBase<DerivedU>&, const MatrixBase<DerivedV>&, Scalar)
148 SelfAdjointView& rankUpdate(const MatrixBase<DerivedU>& u, const Scalar& alpha = Scalar(1))
    [all...]
Fuzzy.h 19 template<typename Derived, typename OtherDerived, bool is_integer = NumTraits<typename Derived::Scalar>::IsInteger>
40 template<typename Derived, typename OtherDerived, bool is_integer = NumTraits<typename Derived::Scalar>::IsInteger>
58 template<typename Derived, bool is_integer = NumTraits<typename Derived::Scalar>::IsInteger>
114 * the value of the reference scalar \a other should come from the Hilbert-Schmidt norm
121 const typename NumTraits<Scalar>::Real& other,
  /external/eigen/Eigen/src/IterativeLinearSolvers/
ConjugateGradient.h 35 typedef typename Dest::Scalar Scalar;
36 typedef Matrix<Scalar,Dynamic,1> VectorType;
72 Scalar alpha = absNew / p.dot(tmp); // the amount we travel on dir
95 typename _Preconditioner = DiagonalPreconditioner<typename _MatrixType::Scalar> >
122 * and NumTraits<Scalar>::epsilon() for the tolerance.
168 typedef typename MatrixType::Scalar Scalar;
  /external/eigen/Eigen/src/SparseCore/
SparseProduct.h 18 typedef typename internal::traits<Lhs>::Scalar Scalar;
28 SparseMatrix<Scalar,0,Index>,
32 SparseMatrix<Scalar,0,Index>,
46 typedef typename _LhsNested::Scalar Scalar;
109 SparseSparseProduct pruned(const Scalar& reference = 0, const RealScalar& epsilon = NumTraits<RealScalar>::dummy_precision()) const
  /external/eigen/test/eigen2/
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>();
  /external/eigen/unsupported/Eigen/src/BVH/
KdBVH.h 18 template<typename Scalar, int Dim>
21 EIGEN_MAKE_ALIGNED_OPERATOR_NEW_IF_VECTORIZABLE_FIXED_SIZE(Scalar, Dim)
22 typedef Matrix<Scalar, Dim, 1> VectorType;
57 * \param _Scalar The underlying scalar type of the bounding boxes
73 typedef _Scalar Scalar;
74 typedef AlignedBox<Scalar, Dim> Volume;
170 typedef internal::vector_int_pair<Scalar, Dim> VIPair;
172 typedef Matrix<Scalar, Dim, 1> VectorType;
  /external/eigen/unsupported/Eigen/src/SVD/
JacobiSVD.h 19 bool IsComplex = NumTraits<typename MatrixType::Scalar>::IsComplex>
69 typedef typename MatrixType::Scalar Scalar;
75 typedef Matrix<Scalar, 1, RowsAtCompileTime, RowMajor, 1, MaxRowsAtCompileTime> WorkspaceType;
110 typedef typename MatrixType::Scalar Scalar;
119 typedef Matrix<Scalar, ColsAtCompileTime, RowsAtCompileTime, Options, MaxColsAtCompileTime, MaxRowsAtCompileTime>
201 typedef typename MatrixType::Scalar Scalar;
211 typedef Matrix<Scalar, ColsAtCompileTime, RowsAtCompileTime, Options, MaxColsAtCompileTime, MaxRowsAtCompileTime
    [all...]
  /external/eigen/unsupported/Eigen/src/SparseExtra/
BlockOfDynamicSparseMatrix.h 66 DynamicSparseMatrix<Scalar,IsRowMajor?RowMajorBit:0> aux(other);
74 SparseVector<Scalar,IsRowMajor ? RowMajorBit : 0> aux(other.innerVector(j));
94 const Scalar& lastCoeff() const
  /external/eigen/unsupported/Eigen/src/FFT/
ei_kissfft_impl.h 20 typedef _Scalar Scalar;
21 typedef std::complex<Scalar> Complex;
34 Scalar phinc = (inverse?2:-2)* acos( (Scalar) -1) / nfft;
151 Fout[m] = Complex( Fout->real() - Scalar(.5)*scratch[3].real() , Fout->imag() - Scalar(.5)*scratch[3].imag() );
267 typedef _Scalar Scalar;
268 typedef std::complex<Scalar> Complex;
305 void fwd( Complex * dst,const Scalar * src,int nfft)
328 dst[k] = (f1k + tw) * Scalar(.5)
    [all...]
  /external/deqp/framework/randomshaders/
rsgExecutionContext.hpp 57 Scalar m_data[EXEC_VEC_WIDTH];
  /external/eigen/Eigen/src/SparseCholesky/
SimplicialCholesky_impl.h 113 Scalar* Lx = m_matrix.valuePtr();
115 ei_declare_aligned_stack_constructed_variable(Scalar, y, size, 0);
153 Scalar yi = y[i]; /* get and clear Y(i) */
157 Scalar l_ki;
  /external/eigen/Eigen/src/SparseLU/
SparseLUImpl.h 19 template <typename Scalar, typename Index>
23 typedef Matrix<Scalar,Dynamic,1> ScalarVector;
26 typedef Ref<Matrix<Scalar,Dynamic,1> > BlockScalarVector;
29 typedef SparseMatrix<Scalar,ColMajor,Index> MatrixType;
SparseLU_Structs.h 78 typedef typename IndexVector::Scalar Index;
  /external/eigen/Eigen/src/misc/
SparseSolve.h 24 typedef SparseMatrix<typename Rhs::Scalar, Rhs::Options, typename Rhs::Index> ReturnType;
73 typedef typename MatrixType::Scalar Scalar; \
92 typedef Matrix<typename Rhs::Scalar,
  /external/eigen/bench/
bench_gemm.cpp 12 #ifndef SCALAR
13 // #define SCALAR std::complex<float>
14 #define SCALAR float
17 typedef SCALAR Scalar;
18 typedef NumTraits<Scalar>::Real RealScalar;
20 typedef Matrix</*Real*/Scalar,Dynamic,Dynamic> B;
21 typedef Matrix<Scalar,Dynamic,Dynamic> C;
125 typedef internal::gebp_traits<Scalar,Scalar> Traits
    [all...]

Completed in 678 milliseconds

<<11121314151617181920>>