Searched defs:Scalar (Results 276 - 300 of 306) sorted by relevance

<<111213

/external/eigen/Eigen/src/Core/
H A DGeneralProduct.h183 // FIXME : maybe the "inner product" could return a Scalar
188 // case, we could have a specialization for Block<MatrixType,1,1> with: operator=(Scalar x);
194 : traits<Matrix<typename scalar_product_traits<typename Lhs::Scalar, typename Rhs::Scalar>::ReturnType,1,1> >
202 public Matrix<typename internal::scalar_product_traits<typename Lhs::Scalar, typename Rhs::Scalar>::ReturnType,1,1>
204 typedef Matrix<typename internal::scalar_product_traits<typename Lhs::Scalar, typename Rhs::Scalar>::ReturnType,1,1> Base;
215 operator const typename Base::Scalar() const {
275 Scalar m_scal
[all...]
H A DPlainObjectBase.h16 # define EIGEN_INITIALIZE_COEFFS_IF_THAT_OPTION_IS_ENABLED for(int i=0;i<base().size();++i) coeffRef(i)=Scalar(0);
19 # define EIGEN_INITIALIZE_COEFFS_IF_THAT_OPTION_IS_ENABLED for(int i=0;i<base().size();++i) coeffRef(i)=std::numeric_limits<Scalar>::quiet_NaN();
97 typedef typename internal::traits<Derived>::Scalar Scalar; typedef in class:Eigen::PlainObjectBase
98 typedef typename internal::packet_traits<Scalar>::type PacketScalar;
99 typedef typename NumTraits<Scalar>::Real RealScalar;
126 DenseStorage<Scalar, Base::MaxSizeAtCompileTime, Base::RowsAtCompileTime, Base::ColsAtCompileTime, Options> m_storage;
138 EIGEN_STRONG_INLINE const Scalar& coeff(Index rowId, Index colId) const
146 EIGEN_STRONG_INLINE const Scalar& coeff(Index index) const
151 EIGEN_STRONG_INLINE Scalar
[all...]
H A DTriangularMatrix.h41 typedef typename internal::traits<Derived>::Scalar Scalar; typedef in class:Eigen::TriangularBase
54 inline Scalar coeff(Index row, Index col) const { return derived().coeff(row,col); }
55 inline Scalar& coeffRef(Index row, Index col) { return derived().coeffRef(row,col); }
65 inline Scalar operator()(Index row, Index col) const
70 inline Scalar& operator()(Index row, Index col)
164 typedef typename internal::traits<TriangularView>::Scalar Scalar; typedef in class:Eigen::TriangularView
205 TriangularView& operator*=(const typename internal::traits<MatrixType>::Scalar& other) { return *this = m_matrix * other; }
207 TriangularView& operator/=(const typename internal::traits<MatrixType>::Scalar
440 typedef typename Derived1::Scalar Scalar; typedef in struct:Eigen::internal::triangular_assignment_selector
477 typedef typename Derived1::Scalar Scalar; typedef in struct:Eigen::internal::triangular_assignment_selector
514 typedef typename Derived1::Scalar Scalar; typedef in struct:Eigen::internal::triangular_assignment_selector
[all...]
H A DVectorwiseOp.h40 typedef typename MemberOp::result_type Scalar; typedef in struct:Eigen::internal::traits
43 typedef typename MatrixType::Scalar InputScalar;
84 EIGEN_STRONG_INLINE const Scalar coeff(Index i, Index j) const
92 const Scalar coeff(Index index) const
110 template<typename Scalar, int Size> struct Cost \
119 EIGEN_MEMBER_FUNCTOR(squaredNorm, Size * NumTraits<Scalar>::MulCost + (Size-1)*NumTraits<Scalar>::AddCost);
120 EIGEN_MEMBER_FUNCTOR(norm, (Size+5) * NumTraits<Scalar>::MulCost + (Size-1)*NumTraits<Scalar>::AddCost);
121 EIGEN_MEMBER_FUNCTOR(stableNorm, (Size+5) * NumTraits<Scalar>
170 typedef typename ExpressionType::Scalar Scalar; typedef in class:Eigen::VectorwiseOp
[all...]
/external/eigen/Eigen/src/Eigenvalues/
H A DRealQZ.h68 typedef typename MatrixType::Scalar Scalar; typedef in class:Eigen::RealQZ
69 typedef std::complex<typename NumTraits<Scalar>::Real> ComplexScalar;
73 typedef Matrix<Scalar, ColsAtCompileTime, 1, Options & ~RowMajor, MaxColsAtCompileTime, 1> ColumnVectorType;
192 Matrix<Scalar,Dynamic,1> m_workspace;
197 Scalar m_normOfT, m_normOfS;
200 typedef Matrix<Scalar,3,1> Vector3s;
201 typedef Matrix<Scalar,2,1> Vector2s;
202 typedef Matrix<Scalar,2,2> Matrix2s;
203 typedef JacobiRotation<Scalar> JR
[all...]
H A DSelfAdjointEigenSolver.h80 /** \brief Scalar type for matrices of type \p _MatrixType. */
81 typedef typename MatrixType::Scalar Scalar; typedef in class:Eigen::SelfAdjointEigenSolver
86 * This is just \c Scalar if #Scalar is real (e.g., \c float or
87 * \c double), and the type of the real part of \c Scalar if #Scalar is
90 typedef typename NumTraits<Scalar>::Real RealScalar;
92 friend struct internal::direct_selfadjoint_eigenvalues<SelfAdjointEigenSolver,Size,NumTraits<Scalar>::IsComplex>;
379 template<int StorageOrder,typename RealScalar, typename Scalar, typenam
492 typedef typename SolverType::Scalar Scalar; typedef in struct:Eigen::internal::direct_selfadjoint_eigenvalues
667 typedef typename SolverType::Scalar Scalar; typedef in struct:Eigen::internal::direct_selfadjoint_eigenvalues
[all...]
/external/eigen/Eigen/src/Geometry/
H A DQuaternion.h42 typedef typename internal::traits<Derived>::Scalar Scalar; typedef in class:Eigen::QuaternionBase
43 typedef typename NumTraits<Scalar>::Real RealScalar;
49 // typedef typename Matrix<Scalar,4,1> Coefficients;
51 typedef Matrix<Scalar,3,1> Vector3;
53 typedef Matrix<Scalar,3,3> Matrix3;
55 typedef AngleAxis<Scalar> AngleAxisType;
60 inline Scalar x() const { return this->derived().coeffs().coeff(0); }
62 inline Scalar y() const { return this->derived().coeffs().coeff(1); }
64 inline Scalar
216 typedef _Scalar Scalar; typedef in struct:Eigen::internal::traits
232 typedef _Scalar Scalar; typedef in class:Eigen::Quaternion
342 typedef _Scalar Scalar; typedef in class:Eigen::Map
379 typedef _Scalar Scalar; typedef in class:Eigen::Map
726 typedef typename Other::Scalar Scalar; typedef in struct:Eigen::internal::quaternionbase_assign_impl
767 typedef typename Other::Scalar Scalar; typedef in struct:Eigen::internal::quaternionbase_assign_impl
[all...]
/external/eigen/Eigen/src/SVD/
H A DJacobiSVD.h19 bool IsComplex = NumTraits<typename MatrixType::Scalar>::IsComplex>
69 typedef typename MatrixType::Scalar Scalar; typedef in class:Eigen::internal::qr_preconditioner_impl
75 typedef Matrix<Scalar, 1, RowsAtCompileTime, RowMajor, 1, MaxRowsAtCompileTime> WorkspaceType;
110 typedef typename MatrixType::Scalar Scalar; typedef in class:Eigen::internal::qr_preconditioner_impl
119 typedef Matrix<Scalar, ColsAtCompileTime, RowsAtCompileTime, Options, MaxColsAtCompileTime, MaxRowsAtCompileTime>
201 typedef typename MatrixType::Scalar Scalar; typedef in class:Eigen::internal::qr_preconditioner_impl
211 typedef Matrix<Scalar, ColsAtCompileTim
300 typedef typename MatrixType::Scalar Scalar; typedef in class:Eigen::internal::qr_preconditioner_impl
369 typedef typename MatrixType::Scalar Scalar; typedef in struct:Eigen::internal::svd_precondition_2x2_block_to_be_real
505 typedef typename MatrixType::Scalar Scalar; typedef in class:Eigen::JacobiSVD
[all...]
/external/eigen/Eigen/src/SparseCholesky/
H A DSimplicialCholesky.h42 typedef typename MatrixType::Scalar Scalar; typedef in class:Eigen::SimplicialCholeskyBase
45 typedef SparseMatrix<Scalar,ColMajor,Index> CholMatrixType;
46 typedef Matrix<Scalar,Dynamic,1> VectorType;
142 s << " L: " << ((total+=(m_matrix.cols()+1) * sizeof(int) + m_matrix.nonZeros()*(sizeof(int)+sizeof(Scalar))) >> 20) << "Mb" << "\n";
143 s << " diag: " << ((total+=m_diag.size() * sizeof(Scalar)) >> 20) << "Mb" << "\n";
222 inline bool operator() (const Index& row, const Index& col, const Scalar&) const
255 typedef typename MatrixType::Scalar Scalar; typedef in struct:Eigen::internal::traits
257 typedef SparseMatrix<Scalar, ColMajo
269 typedef typename MatrixType::Scalar Scalar; typedef in struct:Eigen::internal::traits
312 typedef typename MatrixType::Scalar Scalar; typedef in class:Eigen::SimplicialLLT
401 typedef typename MatrixType::Scalar Scalar; typedef in class:Eigen::SimplicialLDLT
483 typedef typename MatrixType::Scalar Scalar; typedef in class:Eigen::SimplicialCholesky
[all...]
/external/eigen/Eigen/src/SparseCore/
H A DSparseVector.h32 typedef _Scalar Scalar; typedef in struct:Eigen::internal::traits
44 CoeffReadCost = NumTraits<Scalar>::ReadCost,
75 typedef internal::CompressedStorage<Scalar,Index> Storage;
87 EIGEN_STRONG_INLINE const Scalar* valuePtr() const { return &m_data.value(0); }
88 EIGEN_STRONG_INLINE Scalar* valuePtr() { return &m_data.value(0); }
98 inline Scalar coeff(Index row, Index col) const
103 inline Scalar coeff(Index i) const
109 inline Scalar& coeffRef(Index row, Index col)
121 inline Scalar& coeffRef(Index i)
143 inline Scalar
[all...]
/external/eigen/Eigen/src/SparseLU/
H A DSparseLU.h73 class SparseLU : public internal::SparseLUImpl<typename _MatrixType::Scalar, typename _MatrixType::Index>
78 typedef typename MatrixType::Scalar Scalar; typedef in class:Eigen::SparseLU
81 typedef SparseMatrix<Scalar,ColMajor,Index> NCMatrix;
82 typedef internal::MappedSuperNodalMatrix<Scalar, Index> SCMatrix;
83 typedef Matrix<Scalar,Dynamic,1> ScalarVector;
86 typedef internal::SparseLUImpl<Scalar, Index> Base;
144 SparseLUMatrixUReturnType<SCMatrix,MappedSparseMatrix<Scalar,ColMajor,Index> > matrixU() const
146 return SparseLUMatrixUReturnType<SCMatrix, MappedSparseMatrix<Scalar,ColMajor,Index> >(m_Lstore, m_Ustore);
258 Scalar absDeterminan
659 typedef typename MappedSupernodalType::Scalar Scalar; typedef in struct:Eigen::SparseLUMatrixLReturnType
676 typedef typename MatrixLType::Scalar Scalar; typedef in struct:Eigen::SparseLUMatrixUReturnType
[all...]
/external/eigen/Eigen/src/SparseQR/
H A DSparseQR.h70 typedef typename MatrixType::Scalar Scalar; typedef in class:Eigen::SparseQR
73 typedef SparseMatrix<Scalar,ColMajor,Index> QRMatrixType;
75 typedef Matrix<Scalar, Dynamic, 1> ScalarVector;
240 SparseMatrix<Scalar, RowMajor, Index> mQrm(this->m_Q);
406 else tval(curIdx) = Scalar(0);
423 Scalar tdot(0);
450 Scalar tau;
457 Scalar c0 = nzcolQ ? tval(Qidx(0)) : Scalar(
578 typedef typename SparseQRType::Scalar Scalar; typedef in struct:Eigen::SparseQR_QProduct
636 typedef typename SparseQRType::Scalar Scalar; typedef in struct:Eigen::SparseQRMatrixQReturnType
[all...]
/external/eigen/Eigen/src/UmfPackSupport/
H A DUmfPackSupport.h128 typedef typename MatrixType::Scalar Scalar; typedef in class:Eigen::UmfPackLU
131 typedef Matrix<Scalar,Dynamic,1> Vector;
134 typedef SparseMatrix<Scalar> LUMatrixType;
135 typedef SparseMatrix<Scalar,ColMajor,int> UmfpackMatrixType;
149 if(m_symbolic) umfpack_free_symbolic(&m_symbolic,Scalar());
150 if(m_numeric) umfpack_free_numeric(&m_numeric,Scalar());
236 umfpack_free_symbolic(&m_symbolic,Scalar());
238 umfpack_free_numeric(&m_numeric,Scalar());
262 umfpack_free_numeric(&m_numeric,Scalar());
[all...]
/external/eigen/demos/opengl/
H A Dquaternion_demo.cpp139 typedef _Scalar Scalar; typedef in class:EulerAngles
140 typedef Matrix<Scalar,3,3> Matrix3;
141 typedef Matrix<Scalar,3,1> Vector3;
142 typedef Quaternion<Scalar> QuaternionType;
151 inline EulerAngles(Scalar a0, Scalar a1, Scalar a2) : m_angles(a0, a1, a2) {}
/external/eigen/test/
H A Dmain.h268 return a.isApprox(b, test_precision<typename Type1::Scalar>());
278 template<typename Scalar,typename ScalarRef>
279 inline bool test_isApproxWithRef(const Scalar& a, const Scalar& b, const ScalarRef& ref)
288 return m1.isMuchSmallerThan(m2, test_precision<typename internal::traits<Derived1>::Scalar>());
293 const typename NumTraits<typename internal::traits<Derived>::Scalar>::Real& s)
295 return m.isMuchSmallerThan(s, test_precision<typename internal::traits<Derived>::Scalar>());
301 return m.isUnitary(test_precision<typename internal::traits<Derived>::Scalar>());
332 typedef typename internal::traits<MatrixType>::Scalar Scalar; typedef
373 typedef typename PermutationVectorType::Scalar Scalar; typedef
[all...]
/external/eigen/unsupported/Eigen/src/FFT/
H A Dei_kissfft_impl.h20 typedef _Scalar Scalar; typedef in struct:Eigen::internal::kiss_cpx_fft
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; typedef in struct:Eigen::internal::kissfft_impl
268 typedef std::complex<Scalar> Complex;
305 void fwd( Complex * dst,const Scalar * src,int nfft)
328 dst[k] = (f1k + tw) * Scalar(
[all...]
/external/eigen/unsupported/Eigen/src/LevenbergMarquardt/
H A DLevenbergMarquardt.h44 typedef _Scalar Scalar; typedef in struct:Eigen::DenseFunctor
49 typedef Matrix<Scalar,InputsAtCompileTime,1> InputType;
50 typedef Matrix<Scalar,ValuesAtCompileTime,1> ValueType;
51 typedef Matrix<Scalar,ValuesAtCompileTime,InputsAtCompileTime> JacobianType;
71 typedef _Scalar Scalar; typedef in struct:Eigen::SparseFunctor
73 typedef Matrix<Scalar,Dynamic,1> InputType;
74 typedef Matrix<Scalar,Dynamic,1> ValueType;
75 typedef SparseMatrix<Scalar, ColMajor, Index> JacobianType;
98 typename VectorType::Scalar m_delta, typename VectorType::Scalar
116 typedef typename JacobianType::Scalar Scalar; typedef in class:Eigen::LevenbergMarquardt
[all...]
/external/eigen/unsupported/Eigen/src/MatrixFunctions/
H A DMatrixFunction.h36 int IsComplex = NumTraits<typename internal::traits<MatrixType>::Scalar>::IsComplex>
73 typedef typename Traits::Scalar Scalar; typedef in class:Eigen::MatrixFunction
80 typedef std::complex<Scalar> ComplexScalar;
128 typedef typename MatrixType::Scalar Scalar; typedef in class:Eigen::MatrixFunction
133 typedef typename NumTraits<Scalar>::Real RealScalar;
134 typedef Matrix<Scalar, Traits::RowsAtCompileTime, 1> VectorType;
137 typedef std::list<Scalar> Cluster;
139 typedef Matrix<Scalar, Dynami
493 typedef typename Derived::Scalar Scalar; typedef in class:Eigen::MatrixFunctionReturnValue
[all...]
/external/eigen/unsupported/Eigen/src/SVD/
H A DBDCSVD.h47 typedef typename MatrixType::Scalar Scalar; typedef in class:Eigen::BDCSVD
48 typedef typename NumTraits<typename MatrixType::Scalar>::Real RealScalar;
60 typedef Matrix<Scalar, RowsAtCompileTime, RowsAtCompileTime,
63 typedef Matrix<Scalar, ColsAtCompileTime, ColsAtCompileTime,
69 typedef Matrix<Scalar, Dynamic, Dynamic> MatrixX;
/external/eigen/unsupported/test/
H A DNonLinearOptimization.cpp109 typedef _Scalar Scalar; typedef in struct:Functor
114 typedef Matrix<Scalar,InputsAtCompileTime,1> InputType;
115 typedef Matrix<Scalar,ValuesAtCompileTime,1> ValueType;
116 typedef Matrix<Scalar,ValuesAtCompileTime,InputsAtCompileTime> JacobianType;
/external/llvm/include/llvm/Analysis/
H A DDependenceAnalysis.h93 bool Scalar : 1; // Init to true. member in struct:llvm::Dependence::DVEntry
98 DVEntry() : Direction(ALL), Scalar(true), PeelFirst(false),
/external/llvm/lib/MC/MCAnalysis/
H A DMCModuleYAML.cpp233 ScalarTraits<MCModuleYAML::Operand>::input(StringRef Scalar, void *Ctx, argument
237 if (Scalar.size() >= 1)
238 Type = Scalar.front();
243 if (!IRI->matchRegister(Scalar.substr(1), Reg))
248 if (Scalar.substr(1).getAsInteger(10, RIVal))
264 ScalarTraits<MCModuleYAML::OpcodeEnum>::input(StringRef Scalar, void *Ctx, argument
268 if (!IRI->matchOpcode(Scalar, Opc))
/external/llvm/lib/Support/
H A DYAMLTraits.cpp656 StringRef ScalarTraits<bool>::input(StringRef Scalar, void *, bool &Val) { argument
657 if (Scalar.equals("true")) {
660 } else if (Scalar.equals("false")) {
672 StringRef ScalarTraits<StringRef>::input(StringRef Scalar, void *, argument
674 Val = Scalar;
683 StringRef ScalarTraits<std::string>::input(StringRef Scalar, void *, argument
685 Val = Scalar.str();
696 StringRef ScalarTraits<uint8_t>::input(StringRef Scalar, void *, uint8_t &Val) { argument
698 if (getAsUnsignedInteger(Scalar, 0, n))
711 StringRef ScalarTraits<uint16_t>::input(StringRef Scalar, voi argument
727 input(StringRef Scalar, void *, uint32_t &Val) argument
743 input(StringRef Scalar, void *, uint64_t &Val) argument
758 input(StringRef Scalar, void *, int8_t &Val) argument
773 input(StringRef Scalar, void *, int16_t &Val) argument
788 input(StringRef Scalar, void *, int32_t &Val) argument
803 input(StringRef Scalar, void *, int64_t &Val) argument
815 input(StringRef Scalar, void *, double &Val) argument
828 input(StringRef Scalar, void *, float &Val) argument
842 input(StringRef Scalar, void *, Hex8 &Val) argument
857 input(StringRef Scalar, void *, Hex16 &Val) argument
872 input(StringRef Scalar, void *, Hex32 &Val) argument
887 input(StringRef Scalar, void *, Hex64 &Val) argument
[all...]
/external/clang/lib/CodeGen/
H A DCGValue.h38 enum Flavor { Scalar, Complex, Aggregate }; enumerator in enum:clang::CodeGen::RValue::Flavor
46 bool isScalar() const { return V1.getInt() == Scalar; }
73 ER.V1.setInt(Scalar);
/external/eigen/Eigen/src/Core/products/
H A DGeneralBlockPanelKernel.h305 typedef std::complex<RealScalar> Scalar; typedef in class:Eigen::internal::gebp_traits
314 && packet_traits<Scalar>::Vectorizable,
327 typedef typename packet_traits<Scalar>::type ScalarPacket;
334 typedef typename conditional<Vectorizable,RealPacket, Scalar>::type LhsPacket;
335 typedef typename conditional<Vectorizable,DoublePacket,Scalar>::type RhsPacket;
336 typedef typename conditional<Vectorizable,ScalarPacket,Scalar>::type ResPacket;
337 typedef typename conditional<Vectorizable,DoublePacket,Scalar>::type AccPacket;
339 EIGEN_STRONG_INLINE void initAcc(Scalar& p) { p = Scalar(0); }
351 EIGEN_STRONG_INLINE void unpackRhs(DenseIndex n, const Scalar* rh
428 typedef std::complex<RealScalar> Scalar; typedef in class:Eigen::internal::gebp_traits
[all...]

Completed in 412 milliseconds

<<111213