Searched defs:mat (Results 151 - 175 of 221) sorted by relevance

123456789

/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/mesa3d/src/gallium/state_trackers/vega/
H A Dmask.c426 struct matrix *mat = &ctx->state.vg.path_user_to_surface_matrix; local
432 renderer_validate_for_mask_rendering(ctx->renderer, surf, mat);
H A Dmatrix.h83 static INLINE void matrix_init(struct matrix *mat, argument
86 memcpy(mat->m, val, sizeof(VGfloat) * 9);
89 static INLINE void matrix_inits(struct matrix *mat, argument
94 mat->m[0] = m11; mat->m[1] = m12; mat->m[2] = m13;
95 mat->m[3] = m21; mat->m[4] = m22; mat->m[5] = m23;
96 mat
152 matrix_map_point(struct matrix *mat, VGfloat x, VGfloat y, VGfloat *out_x, VGfloat *out_y) argument
212 struct matrix mat; local
246 matrix_determinant(struct matrix *mat) argument
254 matrix_adjoint(struct matrix *mat) argument
271 matrix_divs(struct matrix *mat, VGfloat s) argument
285 matrix_invert(struct matrix *mat) argument
297 matrix_is_invertible(struct matrix *mat) argument
303 matrix_square_to_quad(VGfloat dx0, VGfloat dy0, VGfloat dx1, VGfloat dy1, VGfloat dx3, VGfloat dy3, VGfloat dx2, VGfloat dy2, struct matrix *mat) argument
352 matrix_quad_to_square(VGfloat sx0, VGfloat sy0, VGfloat sx1, VGfloat sy1, VGfloat sx2, VGfloat sy2, VGfloat sx3, VGfloat sy3, struct matrix *mat) argument
367 matrix_quad_to_quad(VGfloat dx0, VGfloat dy0, VGfloat dx1, VGfloat dy1, VGfloat dx2, VGfloat dy2, VGfloat dx3, VGfloat dy3, VGfloat sx0, VGfloat sy0, VGfloat sx1, VGfloat sy1, VGfloat sx2, VGfloat sy2, VGfloat sx3, VGfloat sy3, struct matrix *mat) argument
[all...]
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/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/opencv/cv/src/
H A Dcvconvhull.cpp242 CvMat* mat = 0; local
294 mat = (CvMat*)hull_storage;
296 if( (mat->cols != 1 && mat->rows != 1) || !CV_IS_MAT_CONT(mat->type))
300 if( mat->cols + mat->rows - 1 < ptseq->total )
303 if( CV_MAT_TYPE(mat->type) != CV_SEQ_ELTYPE(ptseq) &&
304 CV_MAT_TYPE(mat->type) != CV_32SC1 )
309 CV_SEQ_KIND_CURVE|CV_MAT_TYPE(mat
573 CvMat* mat = (CvMat*)hull; local
[all...]
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/opencv/cxcore/src/
H A Dcxcopy.cpp493 CvMat stub, *mat = (CvMat*)arr; local
506 if( !CV_IS_MAT(mat))
508 if( CV_IS_MATND(mat))
551 CV_CALL( mat = cvGetMat( mat, &stub, &coi ));
558 type = CV_MAT_TYPE( mat->type );
560 size = cvGetMatSize( mat );
561 mat_step = mat->step;
565 if( CV_IS_MAT_CONT( mat->type ))
573 float* dstdata = (float*)(mat
678 CvMat stub, *mat = (CvMat*)arr; local
[all...]
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...]
/external/skia/src/core/
H A DSkBitmapProcState.cpp98 static SkScalar effective_matrix_scale_sqrd(const SkMatrix& mat) { argument
101 v1.fX = mat.getScaleX();
102 v1.fY = mat.getSkewY();
104 v2.fX = mat.getSkewX();
105 v2.fY = mat.getScaleY();
/external/skia/tests/
H A DMatrix44Test.cpp110 SkMatrix44 mat(SkMatrix44::kUninitialized_Constructor);
113 mat.setTranslate(0, 0, 0);
114 REPORTER_ASSERT(reporter, bits_isonly(mat.getType(), SkMatrix44::kIdentity_Mask));
115 mat.setTranslate(1, 2, 3);
116 REPORTER_ASSERT(reporter, bits_isonly(mat.getType(), SkMatrix44::kTranslate_Mask));
117 REPORTER_ASSERT(reporter, mat.invert(&inverse));
127 mat = a;
128 mat.preTranslate(10, 11, 12);
129 REPORTER_ASSERT(reporter, mat == c);
132 mat
165 make_i(SkMatrix44* mat) argument
166 make_t(SkMatrix44* mat) argument
167 make_s(SkMatrix44* mat) argument
168 make_st(SkMatrix44* mat) argument
172 make_a(SkMatrix44* mat) argument
175 make_p(SkMatrix44* mat) argument
189 test_map2(skiatest::Reporter* reporter, const SkMatrix44& mat) argument
[all...]
H A DMatrixTest.cpp195 SkMatrix mat; local
196 mat.reset();
199 mat.postConcat(mats[x]);
202 SkScalar minScale = mat.getMinScale();
203 SkScalar maxScale = mat.getMaxScale();
205 REPORTER_ASSERT(reporter, (maxScale < 0) == mat.hasPerspective());
208 bool success = mat.getMinMaxScales(scales);
209 REPORTER_ASSERT(reporter, success == !mat.hasPerspective());
212 if (mat.hasPerspective()) {
231 mat
249 SkMatrix mat; local
394 check_matrix_recomposition(const SkMatrix& mat, const SkPoint& rotation1, const SkPoint& scale, const SkPoint& rotation2) argument
418 SkMatrix mat; local
592 SkMatrix mat; local
706 SkMatrix mat, inverse, iden1, iden2; local
[all...]
/external/chromium_org/third_party/mesa/src/src/gallium/state_trackers/vega/
H A Dmatrix.h83 static INLINE void matrix_init(struct matrix *mat, argument
86 memcpy(mat->m, val, sizeof(VGfloat) * 9);
89 static INLINE void matrix_inits(struct matrix *mat, argument
94 mat->m[0] = m11; mat->m[1] = m12; mat->m[2] = m13;
95 mat->m[3] = m21; mat->m[4] = m22; mat->m[5] = m23;
96 mat
152 matrix_map_point(struct matrix *mat, VGfloat x, VGfloat y, VGfloat *out_x, VGfloat *out_y) argument
212 struct matrix mat; local
246 matrix_determinant(struct matrix *mat) argument
254 matrix_adjoint(struct matrix *mat) argument
271 matrix_divs(struct matrix *mat, VGfloat s) argument
285 matrix_invert(struct matrix *mat) argument
297 matrix_is_invertible(struct matrix *mat) argument
303 matrix_square_to_quad(VGfloat dx0, VGfloat dy0, VGfloat dx1, VGfloat dy1, VGfloat dx3, VGfloat dy3, VGfloat dx2, VGfloat dy2, struct matrix *mat) argument
352 matrix_quad_to_square(VGfloat sx0, VGfloat sy0, VGfloat sx1, VGfloat sy1, VGfloat sx2, VGfloat sy2, VGfloat sx3, VGfloat sy3, struct matrix *mat) argument
367 matrix_quad_to_quad(VGfloat dx0, VGfloat dy0, VGfloat dx1, VGfloat dy1, VGfloat dx2, VGfloat dy2, VGfloat dx3, VGfloat dy3, VGfloat sx0, VGfloat sy0, VGfloat sx1, VGfloat sy1, VGfloat sx2, VGfloat sy2, VGfloat sx3, VGfloat sy3, struct matrix *mat) argument
[all...]
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/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/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...]
/external/chromium_org/third_party/qcms/src/
H A Dchain.c418 struct matrix mat; local
422 mat.m[0][0] = transform->matrix.m[0][0];
423 mat.m[1][0] = transform->matrix.m[0][1];
424 mat.m[2][0] = transform->matrix.m[0][2];
425 mat.m[0][1] = transform->matrix.m[1][0];
426 mat.m[1][1] = transform->matrix.m[1][1];
427 mat.m[2][1] = transform->matrix.m[1][2];
428 mat.m[0][2] = transform->matrix.m[2][0];
429 mat.m[1][2] = transform->matrix.m[2][1];
430 mat
450 struct matrix mat; local
[all...]
/external/chromium_org/third_party/skia/src/gpu/
H A DGrPathUtils.cpp25 SkMatrix mat; local
26 mat.setTranslate((i % 2) ? pathBounds.fLeft : pathBounds.fRight,
28 mat.postConcat(viewM);
29 stretch = SkMaxScalar(stretch, mat.mapRadius(SK_Scalar1));
/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/eigen/Eigen/src/SparseCore/
H A DSparseMatrix.h872 InnerIterator(const SparseMatrix& mat, Index outer) argument
873 : m_values(mat.valuePtr()), m_indices(mat.innerIndexPtr()), m_outer(outer), m_id(mat.m_outerIndex[outer])
875 if(mat.isCompressed())
876 m_end = mat.m_outerIndex[outer+1];
878 m_end = m_id + mat.m_innerNonZeros[outer];
905 ReverseInnerIterator(const SparseMatrix& mat, Index outer) argument
906 : m_values(mat.valuePtr()), m_indices(mat
937 set_from_triplets(const InputIterator& begin, const InputIterator& end, SparseMatrixType& mat, int Options = 0) argument
[all...]
/external/eigen/Eigen/src/SuperLUSupport/
H A DSuperLUSupport.h152 MatrixType& mat(_mat.derived());
159 res.nrow = mat.rows();
160 res.ncol = mat.cols();
162 res.storage.lda = MatrixType::IsVectorAtCompileTime ? mat.size() : mat.outerStride();
163 res.storage.values = (void*)(mat.data());
168 static SluMatrix Map(SparseMatrixBase<MatrixType>& mat) argument
174 res.nrow = mat.cols();
175 res.ncol = mat.rows();
180 res.nrow = mat
209 run(MatrixType& mat, SluMatrix& res) argument
228 run(MatrixType& mat, SluMatrix& res) argument
265 asSluMatrix(MatrixType& mat) argument
[all...]
/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/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...]

Completed in 777 milliseconds

123456789