Searched refs:mat (Results 151 - 175 of 313) sorted by relevance

1234567891011>>

/external/opencv/cxcore/include/
H A Dcxcore.h138 CVAPI(CvMat*) cvInitMatHeader( CvMat* mat, int rows, int cols,
147 CVAPI(void) cvReleaseMat( CvMat** mat ); variable
155 CvMat* mat = (CvMat*)arr; local
156 mat->data.ptr = NULL;
157 if( mat->refcount != NULL && --*mat->refcount == 0 )
158 cvFree( &mat->refcount );
159 mat->refcount = NULL;
163 CvMatND* mat = (CvMatND*)arr; local
164 mat
177 CvMat* mat = (CvMat*)arr; local
183 CvMatND* mat = (CvMatND*)arr; local
192 CVAPI(CvMat*) cvCloneMat( const CvMat* mat ); variable
252 CVAPI(CvMatND*) cvCloneMatND( const CvMatND* mat ); variable
258 CVAPI(void) cvReleaseSparseMat( CvSparseMat** mat ); variable
261 CVAPI(CvSparseMat*) cvCloneSparseMat( const CvSparseMat* mat ); variable
777 CVAPI(double) cvDet( const CvArr* mat ); variable
780 CVAPI(CvScalar) cvTrace( const CvArr* mat ); variable
[all...]
/external/eigen/Eigen/src/Geometry/
H A DQuaternion.h728 template<class Derived> static inline void run(QuaternionBase<Derived>& q, const Other& mat) argument
733 Scalar t = mat.trace();
739 q.x() = (mat.coeff(2,1) - mat.coeff(1,2)) * t;
740 q.y() = (mat.coeff(0,2) - mat.coeff(2,0)) * t;
741 q.z() = (mat.coeff(1,0) - mat.coeff(0,1)) * t;
746 if (mat.coeff(1,1) > mat
[all...]
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);
/external/opencv/cv/include/
H A Dcvcompat.h153 CV_INLINE void cvmPerspectiveProject( const CvMat* mat, const CvArr* src, CvArr* dst ) argument
160 cvPerspectiveTransform( &tsrc, &tdst, mat );
164 CV_INLINE void cvFillImage( CvArr* mat, double color ) argument
166 cvSet( mat, cvColorToScalar(color, cvGetElemType(mat)), 0 );
250 CvMat mat = cvMat( 1, len, CV_32F, (void*)dst ); local
251 cvRand( state, &mat );
361 #define cvmSetZero( mat ) cvSetZero( mat )
362 #define cvmSetIdentity( mat ) cvSetIdentit
414 CvMat mat = cvMat( 1, n, CV_32SC2, points ); local
435 CvMat mat = cvMat( 1, count, CV_32FC3, points ); local
445 CvMat mat = cvMat( 1, count, CV_32FC2, points ); local
454 CvMat mat = cvMat( 1, count, CV_32FC2, (void*)points ); local
[all...]
/external/opencv/cv/src/
H A Dcvmoments.cpp382 CvMat stub, *mat = (CvMat*)array; local
410 CV_CALL( mat = cvGetMat( mat, &stub, &coi ));
411 type = CV_MAT_TYPE( mat->type );
417 mat, &contour_header, &block ));
427 type = CV_MAT_TYPE( mat->type );
431 size = cvGetMatSize( mat );
448 int matstep = mat->step ? mat->step : CV_STUB_STEP;
450 IPPI_CALL( ipp_func( mat
[all...]
/external/eigen/Eigen/src/IterativeLinearSolvers/
H A DBiCGSTAB.h19 * \param mat The matrix A
29 bool bicgstab(const MatrixType& mat, const Rhs& rhs, Dest& x, argument
41 int n = mat.cols();
43 VectorType r = rhs - mat * x;
87 v.noalias() = mat * y;
93 t.noalias() = mat * z;
H A DConjugateGradient.h18 * \param mat The matrix A
28 void conjugate_gradient(const MatrixType& mat, const Rhs& rhs, Dest& x, argument
41 int n = mat.cols();
43 VectorType residual = rhs - mat * x; //initial residual
70 tmp.noalias() = mat * p; // the bottleneck of the algorithm
/external/opencv/cxcore/src/
H A Dcxsumpixels.cpp402 CvMat stub, *mat = (CvMat*)arr; local
411 if( !CV_IS_MAT(mat) )
413 if( CV_IS_MATND(mat) )
415 void* matnd = (void*)mat;
467 CV_CALL( mat = cvGetMat( mat, &stub, &coi ));
470 type = CV_MAT_TYPE(mat->type);
471 size = cvGetMatSize( mat );
473 mat_step = mat->step;
475 if( CV_IS_MAT_CONT( mat
593 CvMat stub, *mat = (CvMat*)arr; local
[all...]
H A Dcxrand.cpp452 CvMat stub, *mat = (CvMat*)arr; local
474 if( CV_IS_MATND(mat) )
484 if( !CV_IS_MAT(mat))
487 CV_CALL( mat = cvGetMat( mat, &stub, &coi ));
493 type = CV_MAT_TYPE( mat->type );
494 size = cvGetMatSize( mat );
495 mat_step = mat->step;
497 if( mat->height > 1 && CV_IS_MAT_CONT( mat
[all...]
H A Dcxutils.cpp817 CvMat stub, *mat = (CvMat*)arr; local
827 if( !CV_IS_MAT(mat) )
828 CV_CALL( mat = cvGetMat( mat, &stub ));
833 cols = mat->cols;
834 step = mat->step;
835 arr_size = cols*mat->rows;
837 cont_flag = CV_IS_MAT_CONT(mat->type);
838 elem_size = CV_ELEM_SIZE(mat->type);
841 idata = mat
913 CvMat stub, *mat = (CvMat*)arr; local
[all...]
/external/chromium_org/third_party/mesa/src/src/gallium/state_trackers/xa/
H A Dxa_renderer.c56 map_point(float *mat, float x, float y, float *out_x, float *out_y) argument
58 if (!mat) {
64 *out_x = mat[0] * x + mat[3] * y + mat[6];
65 *out_y = mat[1] * x + mat[4] * y + mat[7];
66 if (!is_affine(mat)) {
67 float w = 1 / (mat[
[all...]
/external/chromium_org/third_party/mesa/src/src/gallium/state_trackers/xorg/
H A Dxorg_renderer.c27 static INLINE void map_point(float *mat, float x, float y, argument
30 if (!mat) {
36 *out_x = mat[0]*x + mat[3]*y + mat[6];
37 *out_y = mat[1]*x + mat[4]*y + mat[7];
38 if (!is_affine(mat)) {
39 float w = 1/(mat[
[all...]
/external/eigen/Eigen/src/SparseCore/
H A DSparseSelfAdjointView.h42 void permute_symm_to_symm(const MatrixType& mat, SparseMatrix<typename MatrixType::Scalar,DestOrder,typename MatrixType::Index>& _dest, const typename MatrixType::Index* perm = 0);
45 void permute_symm_to_fullsymm(const MatrixType& mat, SparseMatrix<typename MatrixType::Scalar,DestOrder,typename MatrixType::Index>& _dest, const typename MatrixType::Index* perm = 0);
314 void permute_symm_to_fullsymm(const MatrixType& mat, SparseMatrix<typename MatrixType::Scalar,DestOrder,typename MatrixType::Index>& _dest, const typename MatrixType::Index* perm) argument
326 Index size = mat.rows();
334 for(typename MatrixType::InnerIterator it(mat,j); it; ++it)
364 for(typename MatrixType::InnerIterator it(mat,j); it; ++it)
401 void permute_symm_to_symm(const MatrixType& mat, SparseMatrix<typename MatrixType::Scalar,DstOrder,typename MatrixType::Index>& _dest, const typename MatrixType::Index* perm) argument
414 Index size = mat.rows();
421 for(typename MatrixType::InnerIterator it(mat,j); it; ++it)
441 for(typename MatrixType::InnerIterator it(mat,
478 SparseSymmetricPermutationProduct(const MatrixType& mat, const Perm& perm) argument
[all...]
H A DSparseView.h38 SparseView(const MatrixType& mat, const Scalar& m_reference = Scalar(0), argument
40 m_matrix(mat), m_reference(m_reference), m_epsilon(m_epsilon) {}
/external/mesa3d/src/gallium/state_trackers/xa/
H A Dxa_renderer.c56 map_point(float *mat, float x, float y, float *out_x, float *out_y) argument
58 if (!mat) {
64 *out_x = mat[0] * x + mat[3] * y + mat[6];
65 *out_y = mat[1] * x + mat[4] * y + mat[7];
66 if (!is_affine(mat)) {
67 float w = 1 / (mat[
[all...]
/external/mesa3d/src/gallium/state_trackers/xorg/
H A Dxorg_renderer.c27 static INLINE void map_point(float *mat, float x, float y, argument
30 if (!mat) {
36 *out_x = mat[0]*x + mat[3]*y + mat[6];
37 *out_y = mat[1]*x + mat[4]*y + mat[7];
38 if (!is_affine(mat)) {
39 float w = 1/(mat[
[all...]
/external/eigen/unsupported/Eigen/src/IterativeSolvers/
H A DIncompleteCholesky.h74 void analyzePattern(const MatrixType& mat) argument
77 ord(mat.template selfadjointView<UpLo>(), m_perm);
132 void IncompleteCholesky<Scalar,_UpLo, OrderingType>::factorize(const _MatrixType& mat) argument
141 if (m_perm.rows() == mat.rows() ) // To detect the null permutation
142 m_L.template selfadjointView<Lower>() = mat.template selfadjointView<_UpLo>().twistedBy(m_perm);
144 m_L.template selfadjointView<Lower>() = mat.template selfadjointView<_UpLo>();
H A DMINRES.h21 * \param mat The matrix A
31 void minres(const MatrixType& mat, const Rhs& rhs, Dest& x, argument
42 const int N(mat.cols()); // the size of the matrix
49 VectorType v_new(rhs-mat*x); //initialize v_new
89 v_new.noalias() = mat*w - beta*v_old; // compute v_new
/external/chromium_org/third_party/mesa/src/src/mesa/drivers/windows/gdi/
H A Dwgl.c483 MAT2 mat; local
491 mat.eM11 = FixedFromDouble(1);
492 mat.eM12 = FixedFromDouble(0);
493 mat.eM21 = FixedFromDouble(0);
494 mat.eM22 = FixedFromDouble(-1);
502 if( GetGlyphOutline(hdc, first, GGO_BITMAP, &gm, 0, NULL, &mat)
517 &gm, 0, NULL, &mat);
535 &mat /* pointer to transformation */
/external/eigen/Eigen/src/Eigen2Support/Geometry/
H A DRotationBase.h116 static inline const MatrixBase<OtherDerived>& ei_toRotationMatrix(const MatrixBase<OtherDerived>& mat) argument
120 return mat;
/external/eigen/Eigen/src/UmfPackSupport/
H A DUmfPackSupport.h298 void grapInput(const MatrixType& mat) argument
300 m_copyMatrix.resize(mat.rows(), mat.cols());
301 if( ((MatrixType::Flags&RowMajorBit)==RowMajorBit) || sizeof(typename MatrixType::Index)!=sizeof(int) || !mat.isCompressed() )
304 m_copyMatrix = mat;
311 m_outerIndexPtr = mat.outerIndexPtr();
312 m_innerIndexPtr = mat.innerIndexPtr();
313 m_valuePtr = mat.valuePtr();
/external/llvm/lib/CodeGen/
H A DRegAllocBase.cpp59 LiveRegMatrix &mat) {
64 Matrix = &mat;
57 init(VirtRegMap &vrm, LiveIntervals &lis, LiveRegMatrix &mat) argument
/external/mesa3d/src/mesa/drivers/windows/gdi/
H A Dwgl.c483 MAT2 mat; local
491 mat.eM11 = FixedFromDouble(1);
492 mat.eM12 = FixedFromDouble(0);
493 mat.eM21 = FixedFromDouble(0);
494 mat.eM22 = FixedFromDouble(-1);
502 if( GetGlyphOutline(hdc, first, GGO_BITMAP, &gm, 0, NULL, &mat)
517 &gm, 0, NULL, &mat);
535 &mat /* pointer to transformation */
/external/eigen/test/
H A Dcholesky.cpp322 MatrixType mat; local
324 mat << 1, 0, 0, -1;
325 LDLT<MatrixType> ldlt(mat);
330 mat << 1, 2, 2, 1;
331 LDLT<MatrixType> ldlt(mat);
336 mat << 0, 0, 0, 0;
337 LDLT<MatrixType> ldlt(mat);
342 mat << 0, 0, 0, 1;
343 LDLT<MatrixType> ldlt(mat);
348 mat <<
[all...]
/external/chromium_org/third_party/skia/bench/
H A DMatrix44Bench.cpp71 , mat(SkMatrix44::kIdentity_Constructor)
78 mat.setRowMajord(rowMajor);
83 mat.setIdentity();
87 SkMatrix44 mat; member in class:SetIdentityMatrix44Bench

Completed in 496 milliseconds

1234567891011>>