Searched refs:mat (Results 51 - 75 of 313) sorted by relevance

1234567891011>>

/external/skia/include/effects/
H A DSkColorMatrix.h50 void preConcat(const SkColorMatrix& mat) { this->setConcat(*this, mat); } argument
51 void postConcat(const SkColorMatrix& mat) { this->setConcat(mat, *this); } argument
/external/chromium_org/third_party/skia/gm/
H A Dfilterindiabox.cpp19 static SkSize computeSize(const SkBitmap& bm, const SkMatrix& mat) { argument
22 mat.mapRect(&bounds);
26 static void draw_row(SkCanvas* canvas, const SkBitmap& bm, const SkMatrix& mat, SkScalar dx) { argument
31 canvas->drawBitmapMatrix(bm, mat, &paint);
35 canvas->drawBitmapMatrix(bm, mat, &paint);
39 canvas->drawBitmapMatrix(bm, mat, &paint);
43 canvas->drawBitmapMatrix(bm, mat, &paint);
/external/chromium_org/third_party/mesa/src/src/mesa/math/
H A Dm_matrix.c105 * \param mat a pointer to a GLmatrix structure.
111 #define TEST_MAT_FLAGS(mat, a) \
112 ((MAT_FLAGS_GEOMETRY & (~(a)) & ((mat)->flags) ) == 0)
206 * \param mat pointer to a GLmatrix structure containing the left multiplication
214 static void matrix_multf( GLmatrix *mat, const GLfloat *m, GLuint flags ) argument
216 mat->flags |= (flags | MAT_DIRTY_TYPE | MAT_DIRTY_INVERSE);
218 if (TEST_MAT_FLAGS(mat, MAT_FLAGS_3D))
219 matmul34( mat->m, mat->m, m );
221 matmul4( mat
794 _math_matrix_rotate( GLmatrix *mat, GLfloat angle, GLfloat x, GLfloat y, GLfloat z ) argument
978 _math_matrix_frustum( GLmatrix *mat, GLfloat left, GLfloat right, GLfloat bottom, GLfloat top, GLfloat nearval, GLfloat farval ) argument
1018 _math_matrix_ortho( GLmatrix *mat, GLfloat left, GLfloat right, GLfloat bottom, GLfloat top, GLfloat nearval, GLfloat farval ) argument
1064 _math_matrix_scale( GLmatrix *mat, GLfloat x, GLfloat y, GLfloat z ) argument
1094 _math_matrix_translate( GLmatrix *mat, GLfloat x, GLfloat y, GLfloat z ) argument
1455 _math_matrix_loadf( GLmatrix *mat, const GLfloat *m ) argument
[all...]
H A Dm_debug_norm.c123 static void ref_norm_transform_rescale( const GLmatrix *mat, argument
131 const GLfloat *m = mat->inv;
146 static void ref_norm_transform_normalize( const GLmatrix *mat, argument
154 const GLfloat *m = mat->inv;
199 GLmatrix mat[1]; local
211 mat->m = (GLfloat *) _mesa_align_malloc( 16 * sizeof(GLfloat), 16 );
212 mat->inv = m = mat->m;
278 ref_norm_transform_rescale( mat, scale, source, NULL, ref );
280 ref_norm_transform_normalize( mat, scal
[all...]
H A Dm_xform.h122 typedef void (_NORMAPIP normal_func)( CONST GLmatrix *mat,
163 #define TransformRaw( to, mat, from ) \
164 ( _mesa_transform_tab[(from)->size][(mat)->type]( to, (mat)->m, from ), \
/external/mesa3d/src/mesa/math/
H A Dm_matrix.c105 * \param mat a pointer to a GLmatrix structure.
111 #define TEST_MAT_FLAGS(mat, a) \
112 ((MAT_FLAGS_GEOMETRY & (~(a)) & ((mat)->flags) ) == 0)
206 * \param mat pointer to a GLmatrix structure containing the left multiplication
214 static void matrix_multf( GLmatrix *mat, const GLfloat *m, GLuint flags ) argument
216 mat->flags |= (flags | MAT_DIRTY_TYPE | MAT_DIRTY_INVERSE);
218 if (TEST_MAT_FLAGS(mat, MAT_FLAGS_3D))
219 matmul34( mat->m, mat->m, m );
221 matmul4( mat
794 _math_matrix_rotate( GLmatrix *mat, GLfloat angle, GLfloat x, GLfloat y, GLfloat z ) argument
978 _math_matrix_frustum( GLmatrix *mat, GLfloat left, GLfloat right, GLfloat bottom, GLfloat top, GLfloat nearval, GLfloat farval ) argument
1018 _math_matrix_ortho( GLmatrix *mat, GLfloat left, GLfloat right, GLfloat bottom, GLfloat top, GLfloat nearval, GLfloat farval ) argument
1064 _math_matrix_scale( GLmatrix *mat, GLfloat x, GLfloat y, GLfloat z ) argument
1094 _math_matrix_translate( GLmatrix *mat, GLfloat x, GLfloat y, GLfloat z ) argument
1455 _math_matrix_loadf( GLmatrix *mat, const GLfloat *m ) argument
[all...]
H A Dm_debug_norm.c123 static void ref_norm_transform_rescale( const GLmatrix *mat, argument
131 const GLfloat *m = mat->inv;
146 static void ref_norm_transform_normalize( const GLmatrix *mat, argument
154 const GLfloat *m = mat->inv;
199 GLmatrix mat[1]; local
211 mat->m = (GLfloat *) _mesa_align_malloc( 16 * sizeof(GLfloat), 16 );
212 mat->inv = m = mat->m;
278 ref_norm_transform_rescale( mat, scale, source, NULL, ref );
280 ref_norm_transform_normalize( mat, scal
[all...]
H A Dm_xform.h122 typedef void (_NORMAPIP normal_func)( CONST GLmatrix *mat,
163 #define TransformRaw( to, mat, from ) \
164 ( _mesa_transform_tab[(from)->size][(mat)->type]( to, (mat)->m, from ), \
/external/opencv/cv/src/
H A Dcvkdtree.cpp61 CvMat* mat; member in struct:CvFeatureTree::deref
62 deref(CvMat* _mat) : mat(_mat) {
66 return *((scalar_type*)(mat->data.ptr + i * mat->step) + j);
70 #define dispatch_cvtype(mat, c) \
71 switch (CV_MAT_DEPTH((mat)->type)) { \
79 CvMat* mat; member in struct:CvFeatureTree
122 dispatch_cvtype(mat, ((__treetype*)data)->
135 CvFeatureTree(CvMat* _mat) : mat(_mat) {
137 // * (a) user ensures *mat outlive
[all...]
/external/eigen/bench/
H A Dsparse_setter.cpp197 SparseMatrix<Scalar> mat(SIZE,SIZE);
198 //mat.startFill(2000000/*coords.size()*/);
201 mat.insert(coords[i].x(), coords[i].y()) = vals[i];
203 mat.finalize();
211 DynamicSparseMatrix<Scalar> mat(SIZE,SIZE);
212 mat.reserve(coords.size()/10);
215 mat.coeffRef(coords[i].x(), coords[i].y()) += vals[i];
217 mat.finalize();
219 return &mat.coeffRef(coords[0].x(), coords[0].y());
226 DynamicSparseMatrix<Scalar> mat(SIZ
250 SparseMatrix<Scalar> mat = setter; local
[all...]
H A DBenchUtil.h21 template<typename MatrixType> void initMatrix_random(MatrixType& mat) __attribute__((noinline));
22 template<typename MatrixType> void initMatrix_random(MatrixType& mat) argument
24 mat.setRandom();// = MatrixType::random(mat.rows(), mat.cols());
27 template<typename MatrixType> void initMatrix_identity(MatrixType& mat) __attribute__((noinline));
28 template<typename MatrixType> void initMatrix_identity(MatrixType& mat) argument
30 mat.setIdentity();
/external/eigen/test/
H A Dproduct_trmm.cpp24 TriMatrix mat(rows,cols), tri(rows,cols), triTr(cols,rows);
34 mat.setRandom();
35 tri = mat.template triangularView<Mode>();
36 triTr = mat.transpose().template triangularView<Mode>();
40 VERIFY_IS_APPROX( ge_xs = mat.template triangularView<Mode>() * ge_right, tri * ge_right);
41 VERIFY_IS_APPROX( ge_sx = ge_left * mat.template triangularView<Mode>(), ge_left * tri);
43 VERIFY_IS_APPROX( ge_xs.noalias() = mat.template triangularView<Mode>() * ge_right, tri * ge_right);
44 VERIFY_IS_APPROX( ge_sx.noalias() = ge_left * mat.template triangularView<Mode>(), ge_left * tri);
46 VERIFY_IS_APPROX( ge_xs.noalias() = (s1*mat.adjoint()).template triangularView<Mode>() * (s2*ge_left.transpose()), s1*triTr.conjugate() * (s2*ge_left.transpose()));
47 VERIFY_IS_APPROX( ge_sx.noalias() = ge_right.transpose() * mat
[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...]
/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 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/blas/
H A DRank2Update.h21 static void run(Index size, Scalar* mat, Index stride, const Scalar* u, const Scalar* v, Scalar alpha) argument
26 Map<Matrix<Scalar,Dynamic,1> >(mat+stride*i+(UpLo==Lower ? i : 0), UpLo==Lower ? size-i : (i+1)) +=
39 static void run(Index size, Scalar* mat, const Scalar* u, const Scalar* v, Scalar alpha) argument
45 Map<Matrix<Scalar,Dynamic,1> >(mat+offset, UpLo==Lower ? size-i : (i+1)) +=
49 mat[offset+(UpLo==Lower ? 0 : i)] = numext::real(mat[offset+(UpLo==Lower ? 0 : i)]);
/external/chromium_org/third_party/skia/src/utils/
H A DSkMatrix44.cpp701 typedef void (*Map2Procf)(const SkMScalar mat[][4], const float src2[], int count, float dst4[]);
702 typedef void (*Map2Procd)(const SkMScalar mat[][4], const double src2[], int count, double dst4[]);
704 static void map2_if(const SkMScalar mat[][4], const float* SK_RESTRICT src2, argument
716 static void map2_id(const SkMScalar mat[][4], const double* SK_RESTRICT src2, argument
728 static void map2_tf(const SkMScalar mat[][4], const float* SK_RESTRICT src2, argument
730 const float mat30 = SkMScalarToFloat(mat[3][0]);
731 const float mat31 = SkMScalarToFloat(mat[3][1]);
732 const float mat32 = SkMScalarToFloat(mat[3][2]);
743 static void map2_td(const SkMScalar mat[][4], const double* SK_RESTRICT src2, argument
746 dst4[0] = src2[0] + mat[
755 map2_sf(const SkMScalar mat[][4], const float* SK_RESTRICT src2, int count, float* SK_RESTRICT dst4) argument
768 map2_sd(const SkMScalar mat[][4], const double* SK_RESTRICT src2, int count, double* SK_RESTRICT dst4) argument
780 map2_af(const SkMScalar mat[][4], const float* SK_RESTRICT src2, int count, float* SK_RESTRICT dst4) argument
798 map2_ad(const SkMScalar mat[][4], const double* SK_RESTRICT src2, int count, double* SK_RESTRICT dst4) argument
812 map2_pf(const SkMScalar mat[][4], const float* SK_RESTRICT src2, int count, float* SK_RESTRICT dst4) argument
827 map2_pd(const SkMScalar mat[][4], const double* SK_RESTRICT src2, int count, double* SK_RESTRICT dst4) argument
[all...]
/external/skia/src/utils/
H A DSkMatrix44.cpp701 typedef void (*Map2Procf)(const SkMScalar mat[][4], const float src2[], int count, float dst4[]);
702 typedef void (*Map2Procd)(const SkMScalar mat[][4], const double src2[], int count, double dst4[]);
704 static void map2_if(const SkMScalar mat[][4], const float* SK_RESTRICT src2, argument
716 static void map2_id(const SkMScalar mat[][4], const double* SK_RESTRICT src2, argument
728 static void map2_tf(const SkMScalar mat[][4], const float* SK_RESTRICT src2, argument
730 const float mat30 = SkMScalarToFloat(mat[3][0]);
731 const float mat31 = SkMScalarToFloat(mat[3][1]);
732 const float mat32 = SkMScalarToFloat(mat[3][2]);
743 static void map2_td(const SkMScalar mat[][4], const double* SK_RESTRICT src2, argument
746 dst4[0] = src2[0] + mat[
755 map2_sf(const SkMScalar mat[][4], const float* SK_RESTRICT src2, int count, float* SK_RESTRICT dst4) argument
768 map2_sd(const SkMScalar mat[][4], const double* SK_RESTRICT src2, int count, double* SK_RESTRICT dst4) argument
780 map2_af(const SkMScalar mat[][4], const float* SK_RESTRICT src2, int count, float* SK_RESTRICT dst4) argument
798 map2_ad(const SkMScalar mat[][4], const double* SK_RESTRICT src2, int count, double* SK_RESTRICT dst4) argument
812 map2_pf(const SkMScalar mat[][4], const float* SK_RESTRICT src2, int count, float* SK_RESTRICT dst4) argument
827 map2_pd(const SkMScalar mat[][4], const double* SK_RESTRICT src2, int count, double* SK_RESTRICT dst4) argument
[all...]
/external/opencv/cxcore/src/
H A Dcxminmaxloc.cpp301 CvMat stub, maskstub, *mat = (CvMat*)img, *matmask = (CvMat*)mask; local
316 if( !CV_IS_MAT(mat) )
317 CV_CALL( mat = cvGetMat( mat, &stub, &coi ));
319 type = CV_MAT_TYPE( mat->type );
322 size = cvGetMatSize( mat );
330 mat_step = mat->step;
331 cont_flag = mat->type;
340 if( !CV_ARE_SIZES_EQ( mat, matmask ))
365 IPPI_CALL( func( mat
[all...]
/external/chromium_org/third_party/WebKit/Source/platform/transforms/
H A DMatrix3DTransformOperation.h65 Matrix3DTransformOperation(const TransformationMatrix& mat) argument
67 m_matrix = mat;
/external/chromium_org/third_party/mesa/src/src/gallium/state_trackers/vega/
H A Dshader.h58 const struct matrix *mat);
59 void shader_set_paint_matrix(struct shader *shader, const struct matrix *mat);
/external/mesa3d/src/gallium/state_trackers/vega/
H A Dshader.h58 const struct matrix *mat);
59 void shader_set_paint_matrix(struct shader *shader, const struct matrix *mat);
/external/eigen/test/eigen2/
H A Deigen2_qr.cpp60 Matrix3d mat; local
61 mat << 1, 45, 1, 2, 2, 2, 1, 2, 3;
62 VERIFY(mat.qr().isFullRank());
63 mat << 1, 1, 1, 2, 2, 2, 1, 2, 3;
65 //VERIFY(!mat.qr().isFullRank());
/external/eigen/Eigen/src/PaStiXSupport/
H A DPaStiXSupport.h89 void c_to_fortran_numbering (MatrixType& mat) argument
91 if ( !(mat.outerIndexPtr()[0]) )
94 for(i = 0; i <= mat.rows(); ++i)
95 ++mat.outerIndexPtr()[i];
96 for(i = 0; i < mat.nonZeros(); ++i)
97 ++mat.innerIndexPtr()[i];
103 void fortran_to_c_numbering (MatrixType& mat) argument
106 if ( mat.outerIndexPtr()[0] == 1 )
109 for(i = 0; i <= mat.rows(); ++i)
110 --mat
315 compute(ColSpMatrix& mat) argument
328 analyzePattern(ColSpMatrix& mat) argument
359 factorize(ColSpMatrix& mat) argument
[all...]
/external/eigen/unsupported/Eigen/src/IterativeSolvers/
H A DIncompleteLU.h29 IncompleteLU(const MatrixType& mat) : m_isInitialized(false) argument
31 compute(mat);
38 IncompleteLU& compute(const MatrixType& mat) argument
40 m_lu = mat;
41 int size = mat.cols();

Completed in 5696 milliseconds

1234567891011>>