Searched refs:mat (Results 101 - 125 of 313) sorted by path

1234567891011>>

/external/deqp/modules/gles3/functional/
H A Des3fTextureUnitTests.cpp184 static Mat4 matExtend3To4 (const Mat3& mat) argument
189 Vec3 row = mat.getRow(rowNdx);
/external/deqp/modules/glshared/
H A DglsBuiltinPrecisionTests.cpp987 ExprP<Matrix<float, Rows, Cols> > operator- (const ExprP<Matrix<float, Rows, Cols> >& mat);
3462 ExprP<float> determinant (ExprP<Matrix<float, Size, Size> > mat) argument
3464 return app<Determinant<Size> >(mat);
3473 ExprP<Mat2> mat = args.a; local
3475 return mat[0][0] * mat[1][1] - mat[1][0] * mat[0][1];
3485 ExprP<Mat3> mat = args.a; local
3487 return (mat[
3499 ExprP<Mat4> mat = args.a; local
3529 inverse(ExprP<Matrix<float, Size, Size> > mat) argument
3546 ExprP<Mat2> mat = args.a; local
3566 ExprP<Mat3> mat = args.a; local
3606 ExprP<Mat4> mat = args.a; local
3899 operator -(const ExprP<Matrix<float, Rows, Cols> >& mat) argument
[all...]
/external/eigen/Eigen/src/Cholesky/
H A DLDLT.h259 static bool unblocked(MatrixType& mat, TranspositionType& transpositions, Workspace& temp, SignMatrix& sign) argument
265 eigen_assert(mat.rows()==mat.cols());
266 const Index size = mat.rows();
271 if (numext::real(mat.coeff(0,0)) > 0) sign = PositiveSemiDef;
272 else if (numext::real(mat.coeff(0,0)) < 0) sign = NegativeSemiDef;
281 mat.diagonal().tail(size-k).cwiseAbs().maxCoeff(&index_of_biggest_in_corner);
290 mat.row(k).head(k).swap(mat.row(index_of_biggest_in_corner).head(k));
291 mat
349 updateInPlace(MatrixType& mat, MatrixBase<WDerived>& w, const typename MatrixType::RealScalar& sigma=1) argument
388 update(MatrixType& mat, const TranspositionType& transpositions, Workspace& tmp, const WType& w, const typename MatrixType::RealScalar& sigma=1) argument
400 unblocked(MatrixType& mat, TranspositionType& transpositions, Workspace& temp, SignMatrix& sign) argument
407 update(MatrixType& mat, TranspositionType& transpositions, Workspace& tmp, WType& w, const typename MatrixType::RealScalar& sigma=1) argument
[all...]
H A DLLT.h191 static typename MatrixType::Index llt_rank_update_lower(MatrixType& mat, const VectorType& vec, const typename MatrixType::RealScalar& sigma) argument
203 Index n = mat.cols();
204 eigen_assert(mat.rows()==n && vec.size()==n);
218 g.makeGivens(mat(i,i), -temp(i), &mat(i,i));
223 ColXprSegment x(mat.col(i).tail(rs));
235 RealScalar Ljj = numext::real(mat.coeff(j,j));
245 mat.coeffRef(j,j) = nLjj;
252 temp.tail(rs) -= (wj/Ljj) * mat.col(j).tail(rs);
254 mat
265 unblocked(MatrixType& mat) argument
325 rankUpdate(MatrixType& mat, const VectorType& vec, const RealScalar& sigma) argument
336 unblocked(MatrixType& mat) argument
342 blocked(MatrixType& mat) argument
348 rankUpdate(MatrixType& mat, const VectorType& vec, const RealScalar& sigma) argument
[all...]
H A DLLT_MKL.h75 static typename MatrixType::Index rankUpdate(MatrixType& mat, const VectorType& vec, const typename MatrixType::RealScalar& sigma) \
76 { return Eigen::internal::llt_rank_update_lower(mat, vec, sigma); } \
86 static typename MatrixType::Index rankUpdate(MatrixType& mat, const VectorType& vec, const typename MatrixType::RealScalar& sigma) \
88 Transpose<MatrixType> matt(mat); \
/external/eigen/Eigen/src/CholmodSupport/
H A DCholmodSupport.h18 void cholmod_configure_matrix(CholmodType& mat) argument
22 mat.xtype = CHOLMOD_REAL;
23 mat.dtype = CHOLMOD_SINGLE;
27 mat.xtype = CHOLMOD_REAL;
28 mat.dtype = CHOLMOD_DOUBLE;
32 mat.xtype = CHOLMOD_COMPLEX;
33 mat.dtype = CHOLMOD_SINGLE;
37 mat.xtype = CHOLMOD_COMPLEX;
38 mat.dtype = CHOLMOD_DOUBLE;
48 /** Wraps the Eigen sparse matrix \a mat int
52 viewAsCholmod(SparseMatrix<_Scalar,_Options,_Index>& mat) argument
99 viewAsCholmod(const SparseMatrix<_Scalar,_Options,_Index>& mat) argument
108 viewAsCholmod(const SparseSelfAdjointView<SparseMatrix<_Scalar,_Options,_Index>, UpLo>& mat) argument
121 viewAsCholmod(MatrixBase<Derived>& mat) argument
[all...]
/external/eigen/Eigen/src/Core/
H A DBooleanRedux.h25 static inline bool run(const Derived &mat) argument
27 return all_unroller<Derived, UnrollCount-1>::run(mat) && mat.coeff(row, col);
34 static inline bool run(const Derived &/*mat*/) { return true; }
51 static inline bool run(const Derived &mat) argument
53 return any_unroller<Derived, UnrollCount-1>::run(mat) || mat.coeff(row, col);
60 static inline bool run(const Derived & /*mat*/) { return false; }
H A DCwiseUnaryView.h66 inline CwiseUnaryView(const MatrixType& mat, const ViewOp& func = ViewOp()) argument
67 : m_matrix(mat), m_functor(func) {}
H A DRedux.h85 static EIGEN_STRONG_INLINE Scalar run(const Derived &mat, const Func& func) argument
87 return func(redux_novec_unroller<Func, Derived, Start, HalfLength>::run(mat,func),
88 redux_novec_unroller<Func, Derived, Start+HalfLength, Length-HalfLength>::run(mat,func));
102 static EIGEN_STRONG_INLINE Scalar run(const Derived &mat, const Func&) argument
104 return mat.coeffByOuterInner(outer, inner);
131 static EIGEN_STRONG_INLINE PacketScalar run(const Derived &mat, const Func& func) argument
134 redux_vec_unroller<Func, Derived, Start, HalfLength>::run(mat,func),
135 redux_vec_unroller<Func, Derived, Start+HalfLength, Length-HalfLength>::run(mat,func) );
152 static EIGEN_STRONG_INLINE PacketScalar run(const Derived &mat, const Func&) argument
154 return mat
173 run(const Derived& mat, const Func& func) argument
199 run(const Derived& mat, const Func& func) argument
257 run(const Derived& mat, const Func& func) argument
299 run(const Derived& mat, const Func& func) argument
[all...]
H A DVectorwiseOp.h78 PartialReduxExpr(const MatrixType& mat, const MemberOp& func = MemberOp()) argument
79 : m_matrix(mat), m_functor(func) {}
113 EIGEN_STRONG_INLINE ResultType operator()(const XprType& mat) const \
114 { return mat.MEMBER(); } \
143 inline result_type operator()(const DenseBase<Derived>& mat) const
144 { return mat.redux(m_functor); }
H A DVisitor.h25 static inline void run(const Derived &mat, Visitor& visitor) argument
27 visitor_impl<Visitor, Derived, UnrollCount-1>::run(mat, visitor);
28 visitor(mat.coeff(row, col), row, col);
35 static inline void run(const Derived &mat, Visitor& visitor) argument
37 return visitor.init(mat.coeff(0, 0), 0, 0);
45 static inline void run(const Derived& mat, Visitor& visitor) argument
47 visitor.init(mat.coeff(0,0), 0, 0);
48 for(Index i = 1; i < mat.rows(); ++i)
49 visitor(mat.coeff(i, 0), i, 0);
50 for(Index j = 1; j < mat
[all...]
/external/eigen/Eigen/src/Core/products/
H A DGeneralMatrixMatrixTriangular.h91 // note that the actual rhs is the transpose/adjoint of mat
193 static void run(MatrixType& mat, const ProductType& prod, const typename MatrixType::Scalar& alpha) argument
232 ::run(actualLhs.size(), mat.data(), mat.outerStride(), actualLhsPtr, actualRhsPtr, actualAlpha);
239 static void run(MatrixType& mat, const ProductType& prod, const typename MatrixType::Scalar& alpha) argument
261 ::run(mat.cols(), actualLhs.cols(),
263 mat.data(), mat.outerStride(), actualAlpha);
H A DSelfadjointProduct.h25 static void run(Index size, Scalar* mat, Index stride, const Scalar* vecX, const Scalar* vecY, const Scalar& alpha) argument
32 Map<Matrix<Scalar,Dynamic,1> >(mat+stride*i+(UpLo==Lower ? i : 0), (UpLo==Lower ? size-i : (i+1)))
41 static void run(Index size, Scalar* mat, Index stride, const Scalar* vecX, const Scalar* vecY, const Scalar& alpha) argument
43 selfadjoint_rank1_update<Scalar,Index,ColMajor,UpLo==Lower?Upper:Lower,ConjRhs,ConjLhs>::run(size,mat,stride,vecY,vecX,alpha);
53 static void run(MatrixType& mat, const OtherType& other, const typename MatrixType::Scalar& alpha) argument
79 ::run(other.size(), mat.data(), mat.outerStride(), actualOtherPtr, actualOtherPtr, actualAlpha);
86 static void run(MatrixType& mat, const OtherType& other, const typename MatrixType::Scalar& alpha) argument
103 ::run(mat.cols(), actualOther.cols(),
105 mat
[all...]
H A DSelfadjointRank2Update.h27 static void run(Scalar* mat, Index stride, const UType& u, const VType& v, const Scalar& alpha) argument
32 Map<Matrix<Scalar,Dynamic,1> >(mat+stride*i+i, size-i) +=
42 static void run(Scalar* mat, Index stride, const UType& u, const VType& v, const Scalar& alpha) argument
46 Map<Matrix<Scalar,Dynamic,1> >(mat+stride*i, i+1) +=
/external/eigen/Eigen/src/Eigen2Support/
H A DCwise.h101 operator+(const Scalar& scalar, const Cwise& mat) argument
102 { return mat + scalar; }
/external/eigen/Eigen/src/Eigen2Support/Geometry/
H A DAngleAxis.h174 /** Set \c *this from a 3x3 rotation matrix \a mat.
178 AngleAxis<Scalar>& AngleAxis<Scalar>::operator=(const MatrixBase<Derived>& mat) argument
182 return *this = QuaternionType(mat);
H A DHyperplane.h189 /** Applies the transformation matrix \a mat to \c *this and returns a reference to \c *this.
191 * \param mat the Dim x Dim transformation matrix
192 * \param traits specifies whether the matrix \a mat represents an Isometry
196 inline Hyperplane& transform(const MatrixBase<XprType>& mat, TransformTraits traits = Affine) argument
199 normal() = mat.inverse().transpose() * normal();
201 normal() = mat * normal();
H A DQuaternion.h450 static inline void run(Quaternion<Scalar>& q, const Other& mat) argument
454 Scalar t = mat.trace();
460 q.x() = (mat.coeff(2,1) - mat.coeff(1,2)) * t;
461 q.y() = (mat.coeff(0,2) - mat.coeff(2,0)) * t;
462 q.z() = (mat.coeff(1,0) - mat.coeff(0,1)) * t;
467 if (mat.coeff(1,1) > mat
[all...]
H A DRotation2D.h121 /** Set \c *this from a 2x2 rotation matrix \a mat.
127 Rotation2D<Scalar>& Rotation2D<Scalar>::fromRotationMatrix(const MatrixBase<Derived>& mat) argument
130 m_angle = ei_atan2(mat.coeff(1,0), mat.coeff(0,0));
H A DRotationBase.h116 static inline const MatrixBase<OtherDerived>& ei_toRotationMatrix(const MatrixBase<OtherDerived>& mat) argument
120 return mat;
H A DTransform.h220 friend inline Transform operator*(const LinearMatrixType& mat, const Transform& t) argument
224 res.matrix().template block<Dim,HDim>(0,0) = (mat * t.matrix().template block<Dim,HDim>(0,0)).lazy();
/external/eigen/Eigen/src/Eigenvalues/
H A DSelfAdjointEigenSolver.h409 MatrixType& mat = m_eivec; local
412 mat = matrix.template triangularView<Lower>();
413 RealScalar scale = mat.cwiseAbs().maxCoeff();
415 mat.template triangularView<Lower>() /= scale;
417 internal::tridiagonalization_inplace(mat, diag, m_subdiag, computeEigenvectors);
543 static inline void run(SolverType& solver, const MatrixType& mat, int options) argument
546 eigen_assert(mat.cols() == 3 && mat.cols() == mat.rows());
556 Scalar scale = mat
678 run(SolverType& solver, const MatrixType& mat, int options) argument
[all...]
H A DTridiagonalization.h388 * \param[in,out] mat On input, the selfadjoint matrix whose tridiagonal
397 * decomposition is computed and stored in \p mat.
399 * Computes the tridiagonal decomposition of the selfadjoint matrix \p mat in place
400 * such that \f$ mat = Q T Q^* \f$ where \f$ Q \f$ is unitary and \f$ T \f$ a real
404 * \p extractQ is true, then the orthogonal matrix Q is passed to \p mat. Otherwise the lower
405 * part of the matrix \p mat is destroyed.
409 * vector \p diag should equal the number of rows in \p mat, and the
427 void tridiagonalization_inplace(MatrixType& mat, DiagonalType& diag, SubDiagonalType& subdiag, bool extractQ) argument
429 eigen_assert(mat.cols()==mat
443 run(MatrixType& mat, DiagonalType& diag, SubDiagonalType& subdiag, bool extractQ) argument
467 run(MatrixType& mat, DiagonalType& diag, SubDiagonalType& subdiag, bool extractQ) argument
511 run(MatrixType& mat, DiagonalType& diag, SubDiagonalType&, bool extractQ) argument
535 TridiagonalizationMatrixTReturnType(const MatrixType& mat) argument
[all...]
/external/eigen/Eigen/src/Geometry/
H A DAngleAxis.h179 /** Set \c *this from a 3x3 rotation matrix \a mat.
183 AngleAxis<Scalar>& AngleAxis<Scalar>::operator=(const MatrixBase<Derived>& mat) argument
187 return *this = QuaternionType(mat);
195 AngleAxis<Scalar>& AngleAxis<Scalar>::fromRotationMatrix(const MatrixBase<Derived>& mat) argument
197 return *this = QuaternionType(mat);
H A DHyperplane.h201 /** Applies the transformation matrix \a mat to \c *this and returns a reference to \c *this.
203 * \param mat the Dim x Dim transformation matrix
204 * \param traits specifies whether the matrix \a mat represents an #Isometry
208 inline Hyperplane& transform(const MatrixBase<XprType>& mat, TransformTraits traits = Affine) argument
211 normal() = mat.inverse().transpose() * normal();
213 normal() = mat * normal();

Completed in 399 milliseconds

1234567891011>>