Searched refs:mat (Results 76 - 100 of 315) sorted by relevance

1234567891011>>

/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/eigen/Eigen/src/Cholesky/
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/unsupported/Eigen/src/IterativeSolvers/
H A DScaling.h66 * Compute the left and right diagonal matrices to scale the input matrix @p mat
72 void compute (const MatrixType& mat) argument
74 int m = mat.rows();
75 int n = mat.cols();
81 m_matrix = mat;
141 void computeRef (MatrixType& mat) argument
143 compute (mat);
144 mat = m_matrix;
/external/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/deqp/modules/gles3/functional/
H A Des3fShaderMatrixTests.cpp25 * - mat OP mat
26 * - mat OP vec
27 * - vec OP mat
28 * - mat OP scalar
29 * - OP ( mat )
31 * - OP mat
638 tcu::Matrix<T, Cols, Rows> transpose (const tcu::Matrix<T, Rows, Cols>& mat) argument
644 retVal(c, r) = mat(r, c);
666 float determinant (const tcu::Matrix<float, Size, Size>& mat);
669 determinant(const tcu::Matrix<float, 2, 2>& mat) argument
675 determinant(const tcu::Matrix<float, 3, 3>& mat) argument
686 determinant(const tcu::Matrix<float, 4, 4>& mat) argument
724 inverse(const tcu::Matrix<float, 2, 2>& mat) argument
740 inverse(const tcu::Matrix<float, 3, 3>& mat) argument
790 inverse(const tcu::Matrix<float, 4, 4>& mat) argument
845 negate(const tcu::Matrix<T, Rows, Cols>& mat) argument
859 increment(const tcu::Matrix<T, Rows, Cols>& mat) argument
871 decrement(const tcu::Matrix<T, Rows, Cols>& mat) argument
[all...]
/external/opencv/cxcore/include/
H A Dcxtypes.h582 #define CV_IS_MAT_HDR(mat) \
583 ((mat) != NULL && \
584 (((const CvMat*)(mat))->type & CV_MAGIC_MASK) == CV_MAT_MAGIC_VAL && \
585 ((const CvMat*)(mat))->cols > 0 && ((const CvMat*)(mat))->rows > 0)
587 #define CV_IS_MAT(mat) \
588 (CV_IS_MAT_HDR(mat) && ((const CvMat*)(mat))->data.ptr != NULL)
590 #define CV_IS_MASK_ARR(mat) \
591 (((mat)
651 cvmGet( const CvMat* mat, int row, int col ) argument
669 cvmSet( CvMat* mat, int row, int col, double value ) argument
780 CvSparseMat* mat; member in struct:CvSparseMatIterator
815 CvMatND mat; /* Embedded matrix header for array histograms. */ member in struct:CvHistogram
[all...]
/external/opencv/cv/src/
H A Dcvhistogram.cpp65 CV_CALL( hist->bins = cvInitMatNDHeader( &hist->mat, dims, sizes,
109 CV_CALL( hist->bins = cvInitMatNDHeader( &hist->mat, dims, sizes,
199 CvMat mat; local
200 CV_CALL( cvGetMat( hist->bins, &mat, 0, 1 ));
201 CV_CALL( cvThreshold( &mat, &mat, thresh, 0, CV_THRESH_TOZERO ));
205 CvSparseMat* mat = (CvSparseMat*)hist->bins; local
209 for( node = cvInitSparseMatIterator( mat, &iterator );
212 float* val = (float*)CV_NODE_VAL( mat, node );
236 CvMat mat; local
245 CvSparseMat* mat = (CvSparseMat*)hist->bins; local
292 CvMat mat; local
338 CvSparseMat* mat = (CvSparseMat*)hist->bins; local
1067 CvSparseMat* mat = (CvSparseMat*)(hist->bins); local
1148 CvMatND* mat = (CvMatND*)(hist->bins); local
1333 CvSparseMat* mat = (CvSparseMat*)(hist->bins); local
1428 CvMat stub, *mat = (CvMat*)img[i]; local
1457 CvMat stub, *mat = (CvMat*)mask; local
1495 CvSparseMat* mat = (CvSparseMat*)(hist->bins); local
1533 CvSparseMat* mat = (CvSparseMat*)(hist->bins); local
1573 CvMatND* mat = (CvMatND*)(hist->bins); local
1778 CvSparseMat* mat = (CvSparseMat*)(hist->bins); local
1841 CvMatND* mat = (CvMatND*)(hist->bins); local
1984 CvSparseMat* mat = (CvSparseMat*)(hist->bins); local
2072 CvMat stub, *mat = (CvMat*)(i < dims ? img[i] : dst); local
2176 CvMat stub, *mat; local
2384 CvMatND * mat = (CvMatND *) cvReadByName( fs, node, "mat" ); local
[all...]
H A Dcvaccum.cpp395 CvMat stub, *mat = (CvMat*)arr; local
405 if( !CV_IS_MAT( mat ) || !CV_IS_MAT( sum ))
408 CV_CALL( mat = cvGetMat( mat, &stub, &coi1 ));
417 if( !CV_ARE_CNS_EQ( mat, sum ))
424 if( !CV_ARE_SIZES_EQ( mat, sum ))
427 size = cvGetMatSize( mat );
428 type = CV_MAT_TYPE( mat->type );
430 mat_step = mat->step;
441 if( CV_IS_MAT_CONT( mat
497 CvMat stub, *mat = (CvMat*)arr; local
705 CvMat stub, *mat = (CvMat*)arrY; local
[all...]
/external/chromium_org/third_party/mesa/src/src/gallium/state_trackers/vega/
H A Dpaint.c283 struct matrix mat; local
284 matrix_load_identity(&mat);
286 matrix_translate(&mat, -paint->gradient.linear.coords[0], -paint->gradient.linear.coords[1]);
287 matrix_mult(&mat, inv);
289 map[8] = mat.m[0]; map[9] = mat.m[3]; map[10] = mat.m[6]; map[11] = 0.f;
290 map[12] = mat.m[1]; map[13] = mat.m[4]; map[14] = mat
339 struct matrix mat; local
368 struct matrix mat; local
729 paint_fill_constant_buffer(struct vg_paint *paint, const struct matrix *mat, void *buffer) argument
[all...]
/external/mesa3d/src/gallium/state_trackers/vega/
H A Dpaint.c283 struct matrix mat; local
284 matrix_load_identity(&mat);
286 matrix_translate(&mat, -paint->gradient.linear.coords[0], -paint->gradient.linear.coords[1]);
287 matrix_mult(&mat, inv);
289 map[8] = mat.m[0]; map[9] = mat.m[3]; map[10] = mat.m[6]; map[11] = 0.f;
290 map[12] = mat.m[1]; map[13] = mat.m[4]; map[14] = mat
339 struct matrix mat; local
368 struct matrix mat; local
729 paint_fill_constant_buffer(struct vg_paint *paint, const struct matrix *mat, void *buffer) argument
[all...]
/external/chromium_org/third_party/mesa/src/src/mesa/math/
H A Dm_matrix.h100 _math_matrix_loadf( GLmatrix *mat, const GLfloat *m );
103 _math_matrix_translate( GLmatrix *mat, GLfloat x, GLfloat y, GLfloat z );
110 _math_matrix_scale( GLmatrix *mat, GLfloat x, GLfloat y, GLfloat z );
113 _math_matrix_ortho( GLmatrix *mat,
119 _math_matrix_frustum( GLmatrix *mat,
135 _math_matrix_analyse( GLmatrix *mat );
H A Dm_norm_tmp.h35 * mat - the 4x4 transformation matrix
43 TAG(transform_normalize_normals)( const GLmatrix *mat, argument
53 const GLfloat *m = mat->inv;
110 TAG(transform_normalize_normals_no_rot)( const GLmatrix *mat, argument
120 const GLfloat *m = mat->inv;
175 TAG(transform_rescale_normals_no_rot)( const GLmatrix *mat, argument
185 const GLfloat *m = mat->inv;
204 TAG(transform_rescale_normals)( const GLmatrix *mat, argument
217 const GLfloat *m = mat->inv;
236 TAG(transform_normals_no_rot)( const GLmatrix *mat, argument
266 transform_normals( const GLmatrix *mat, GLfloat scale, const GLvector4f *in, const GLfloat *lengths, GLvector4f *dest ) argument
296 normalize_normals( const GLmatrix *mat, GLfloat scale, const GLvector4f *in, const GLfloat *lengths, GLvector4f *dest ) argument
342 rescale_normals( const GLmatrix *mat, GLfloat scale, const GLvector4f *in, const GLfloat *lengths, GLvector4f *dest ) argument
[all...]
/external/eigen/Eigen/src/SparseCore/
H A DSparseColEtree.h55 * \param mat The matrix in column-major format.
58 * \param perm The permutation to apply to the column of \b mat
61 int coletree(const MatrixType& mat, IndexVector& parent, IndexVector& firstRowElt, typename MatrixType::Index *perm=0) argument
64 Index nc = mat.cols(); // Number of columns
65 Index m = mat.rows();
71 parent.resize(mat.cols());
82 for (typename MatrixType::InnerIterator it(mat, pcol); it; ++it)
104 for (typename MatrixType::InnerIterator it(mat, pcol); it||!found_diag; ++it)
/external/mesa3d/src/mesa/math/
H A Dm_matrix.h100 _math_matrix_loadf( GLmatrix *mat, const GLfloat *m );
103 _math_matrix_translate( GLmatrix *mat, GLfloat x, GLfloat y, GLfloat z );
110 _math_matrix_scale( GLmatrix *mat, GLfloat x, GLfloat y, GLfloat z );
113 _math_matrix_ortho( GLmatrix *mat,
119 _math_matrix_frustum( GLmatrix *mat,
135 _math_matrix_analyse( GLmatrix *mat );
H A Dm_norm_tmp.h35 * mat - the 4x4 transformation matrix
43 TAG(transform_normalize_normals)( const GLmatrix *mat, argument
53 const GLfloat *m = mat->inv;
110 TAG(transform_normalize_normals_no_rot)( const GLmatrix *mat, argument
120 const GLfloat *m = mat->inv;
175 TAG(transform_rescale_normals_no_rot)( const GLmatrix *mat, argument
185 const GLfloat *m = mat->inv;
204 TAG(transform_rescale_normals)( const GLmatrix *mat, argument
217 const GLfloat *m = mat->inv;
236 TAG(transform_normals_no_rot)( const GLmatrix *mat, argument
266 transform_normals( const GLmatrix *mat, GLfloat scale, const GLvector4f *in, const GLfloat *lengths, GLvector4f *dest ) argument
296 normalize_normals( const GLmatrix *mat, GLfloat scale, const GLvector4f *in, const GLfloat *lengths, GLvector4f *dest ) argument
342 rescale_normals( const GLmatrix *mat, GLfloat scale, const GLvector4f *in, const GLfloat *lengths, GLvector4f *dest ) argument
[all...]
/external/chromium_org/third_party/skia/tools/
H A DCopyTilesRenderer.cpp54 SkMatrix mat(fCanvas->getTotalMatrix());
55 mat.postTranslate(SkIntToScalar(-x), SkIntToScalar(-y));
56 fCanvas->setMatrix(mat);
/external/eigen/Eigen/src/QR/
H A DHouseholderQR.h219 void householder_qr_inplace_unblocked(MatrixQR& mat, HCoeffs& hCoeffs, typename MatrixQR::Scalar* tempData = 0) argument
224 Index rows = mat.rows();
225 Index cols = mat.cols();
244 mat.col(k).tail(remainingRows).makeHouseholderInPlace(hCoeffs.coeffRef(k), beta);
245 mat.coeffRef(k,k) = beta;
248 mat.bottomRightCorner(remainingRows, remainingCols)
249 .applyHouseholderOnTheLeft(mat.col(k).tail(remainingRows-1), hCoeffs.coeffRef(k), tempData+k+1);
255 void householder_qr_inplace_blocked(MatrixQR& mat, HCoeffs& hCoeffs, argument
263 Index rows = mat.rows();
264 Index cols = mat
[all...]
/external/skia/tools/
H A DCopyTilesRenderer.cpp54 SkMatrix mat(fCanvas->getTotalMatrix());
55 mat.postTranslate(SkIntToScalar(-x), SkIntToScalar(-y));
56 fCanvas->setMatrix(mat);
/external/chromium_org/third_party/mesa/src/src/mesa/program/
H A Dprog_statevars.c59 const struct gl_material *mat = &ctx->Light.Material; local
69 COPY_4V(value, mat->Attrib[MAT_ATTRIB_FRONT_AMBIENT + face]);
72 COPY_4V(value, mat->Attrib[MAT_ATTRIB_FRONT_DIFFUSE + face]);
75 COPY_4V(value, mat->Attrib[MAT_ATTRIB_FRONT_SPECULAR + face]);
78 COPY_4V(value, mat->Attrib[MAT_ATTRIB_FRONT_EMISSION + face]);
81 value[0] = mat->Attrib[MAT_ATTRIB_FRONT_SHININESS + face][0];
291 const gl_state_index mat = state[0]; local
302 if (mat == STATE_MODELVIEW_MATRIX) {
305 else if (mat == STATE_PROJECTION_MATRIX) {
308 else if (mat
1001 const gl_state_index mat = state[0]; local
1084 load_matrix(GLfloat registers[][4], GLuint pos, const GLfloat mat[16]) argument
1100 load_transpose_matrix(GLfloat registers[][4], GLuint pos, const GLfloat mat[16]) argument
1119 GLmatrix *mat; local
[all...]
/external/chromium_org/third_party/skia/samplecode/
H A DSampleSkLayer.cpp15 static void test_inv(const char label[], const SkMatrix44& mat) { argument
17 mat.dump();
20 if (mat.invert(&inv)) {
27 a.setConcat(mat, inv);
28 b.setConcat(inv, mat);
29 SkDebugf("concat mat with inverse pre=%d post=%d\n", a.isIdentity(), b.isIdentity());
40 const SkMatrix44& mat,
44 dst = mat * src;
52 static void test_33(const SkMatrix44& mat, argument
55 SkMatrix dst = mat;
39 test_map(SkScalar x0, SkScalar y0, SkScalar z0, const SkMatrix44& mat, SkScalar x1, SkScalar y1, SkScalar z1) argument
[all...]
/external/mesa3d/src/mesa/program/
H A Dprog_statevars.c59 const struct gl_material *mat = &ctx->Light.Material; local
69 COPY_4V(value, mat->Attrib[MAT_ATTRIB_FRONT_AMBIENT + face]);
72 COPY_4V(value, mat->Attrib[MAT_ATTRIB_FRONT_DIFFUSE + face]);
75 COPY_4V(value, mat->Attrib[MAT_ATTRIB_FRONT_SPECULAR + face]);
78 COPY_4V(value, mat->Attrib[MAT_ATTRIB_FRONT_EMISSION + face]);
81 value[0] = mat->Attrib[MAT_ATTRIB_FRONT_SHININESS + face][0];
291 const gl_state_index mat = state[0]; local
302 if (mat == STATE_MODELVIEW_MATRIX) {
305 else if (mat == STATE_PROJECTION_MATRIX) {
308 else if (mat
1001 const gl_state_index mat = state[0]; local
1084 load_matrix(GLfloat registers[][4], GLuint pos, const GLfloat mat[16]) argument
1100 load_transpose_matrix(GLfloat registers[][4], GLuint pos, const GLfloat mat[16]) argument
1119 GLmatrix *mat; local
[all...]
/external/skia/samplecode/
H A DSampleSkLayer.cpp15 static void test_inv(const char label[], const SkMatrix44& mat) { argument
17 mat.dump();
20 if (mat.invert(&inv)) {
27 a.setConcat(mat, inv);
28 b.setConcat(inv, mat);
29 SkDebugf("concat mat with inverse pre=%d post=%d\n", a.isIdentity(), b.isIdentity());
40 const SkMatrix44& mat,
44 dst = mat * src;
52 static void test_33(const SkMatrix44& mat, argument
55 SkMatrix dst = mat;
39 test_map(SkScalar x0, SkScalar y0, SkScalar z0, const SkMatrix44& mat, SkScalar x1, SkScalar y1, SkScalar z1) argument
[all...]
/external/eigen/Eigen/src/SparseQR/
H A DSparseQR.h81 /** Construct a QR factorization of the matrix \a mat.
83 * \warning The matrix \a mat must be in compressed mode (see SparseMatrix::makeCompressed()).
87 SparseQR(const MatrixType& mat) : m_isInitialized(false), m_analysisIsok(false), m_lastError(""), m_useDefaultThreshold(true),m_isQSorted(false) argument
89 compute(mat);
92 /** Computes the QR factorization of the sparse matrix \a mat.
94 * \warning The matrix \a mat must be in compressed mode (see SparseMatrix::makeCompressed()).
98 void compute(const MatrixType& mat) argument
100 analyzePattern(mat);
101 factorize(mat);
103 void analyzePattern(const MatrixType& mat);
281 analyzePattern(const MatrixType& mat) argument
319 factorize(const MatrixType& mat) argument
[all...]

Completed in 483 milliseconds

1234567891011>>