HomeSort by relevance Sort by last modified time
    Searched refs:mat (Results 201 - 225 of 392) sorted by null

1 2 3 4 5 6 7 891011>>

  /external/opencv/cxcore/src/
cxrand.cpp 452 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->type )
    [all...]
cxutils.cpp 817 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->data.i
913 CvMat stub, *mat = (CvMat*)arr; local
    [all...]
cxmatrix.cpp 55 CvMat stub, *mat = (CvMat*)array; local
62 if( !CV_IS_MAT( mat ))
65 CV_CALL( mat = cvGetMat( mat, &stub, &coi ));
70 size = cvGetMatSize( mat );
73 type = CV_MAT_TYPE(mat->type);
77 if( CV_IS_MAT_CONT( mat->type ))
83 data = mat->data.ptr;
84 step = mat->step;
138 CvMat stub, *mat = 0 local
777 CvMat stub, *mat = (CvMat*)arr; local
    [all...]
  /external/skia/src/core/
SkMatrix.cpp 17 static void normalize_perspective(SkScalar mat[9]) {
27 if (0 == mat[SkMatrix::kMPersp0] && 0 == mat[SkMatrix::kMPersp1]) {
28 SkScalar p2 = mat[SkMatrix::kMPersp2];
32 mat[i] = SkDoubleToScalar(mat[i] * inv);
34 mat[SkMatrix::kMPersp2] = 1;
707 //SkDebugf("Concat mat non-persp type: %d\n", tmp.getType());
715 void SkMatrix::preConcat(const SkMatrix& mat) {
718 if(!mat.isIdentity())
    [all...]
  /device/google/contexthub/firmware/inc/algos/
mag_cal.h 24 #include <algos/mat.h>
  /external/eigen/Eigen/src/Geometry/
AngleAxis.h 179 /** Set \c *this from a 3x3 rotation matrix \a mat.
183 AngleAxis<Scalar>& AngleAxis<Scalar>::operator=(const MatrixBase<Derived>& mat)
187 return *this = QuaternionType(mat);
195 AngleAxis<Scalar>& AngleAxis<Scalar>::fromRotationMatrix(const MatrixBase<Derived>& mat)
197 return *this = QuaternionType(mat);
  /external/eigen/Eigen/src/IterativeLinearSolvers/
ConjugateGradient.h 18 * \param mat The matrix A
28 void conjugate_gradient(const MatrixType& mat, const Rhs& rhs, Dest& x,
41 int n = mat.cols();
43 VectorType residual = rhs - mat * x; //initial residual
70 tmp.noalias() = mat * p; // the bottleneck of the algorithm
  /external/eigen/unsupported/Eigen/src/IterativeSolvers/
MINRES.h 21 * \param mat The matrix A
31 void minres(const MatrixType& mat, const Rhs& rhs, Dest& x,
52 const int N(mat.cols()); // the size of the matrix
58 VectorType v_new(rhs-mat*x); //initialize v_new
98 v_new.noalias() = mat*w - beta*v_old; // compute v_new
GMRES.h 23 * \param mat matrix of linear system of equations
56 bool gmres(const MatrixType & mat, const Rhs & rhs, Dest & x, const Preconditioner & precond,
71 const int m = mat.rows();
73 VectorType p0 = rhs - mat*x;
105 // apply matrix M to v: v = mat * v;
106 VectorType t=mat*v;
177 // reset data for a restart r0 = rhs - mat * x;
178 VectorType p0=mat*x;
  /external/opencv3/modules/imgproc/test/
test_distancetransform.cpp 134 Mat& mat = test_mat[INPUT][0]; local
136 int i = cvtest::randInt(rng) % mat.rows;
137 int j = cvtest::randInt(rng) % mat.cols;
138 mat.at<uchar>(i,j) = 0;
  /external/opencv3/samples/gpu/
pyrlk_optical_flow.cpp 19 Mat mat(1, d_mat.cols, CV_32FC2, (void*)&vec[0]);
20 d_mat.download(mat);
26 Mat mat(1, d_mat.cols, CV_8UC1, (void*)&vec[0]);
27 d_mat.download(mat);
30 static void drawArrows(Mat& frame, const vector<Point2f>& prevPts, const vector<Point2f>& nextPts, const vector<uchar>& status, Scalar line_color = Scalar(0, 0, 255))
118 Mat frame0 = imread(fname0);
119 Mat frame1 = imread(fname1);
135 Mat frame0Gray
    [all...]
  /external/skia/bench/
Matrix44Bench.cpp 71 , mat(SkMatrix44::kIdentity_Constructor)
78 mat.setRowMajord(rowMajor);
83 mat.setIdentity();
87 SkMatrix44 mat; member in class:SetIdentityMatrix44Bench
  /external/libgdx/gdx/src/com/badlogic/gdx/math/
Vector2.java 294 * @param mat the matrix
296 public Vector2 mul (Matrix3 mat) {
297 float x = this.x * mat.val[0] + this.y * mat.val[3] + mat.val[6];
298 float y = this.x * mat.val[1] + this.y * mat.val[4] + mat.val[7];
  /external/mesa3d/src/mesa/drivers/dri/nouveau/
nv10_state_tnl.c 322 float (*mat)[4] = ctx->Light.Material.Attrib;
328 COPY_3V(c_factor, mat[MAT_ATTRIB_FRONT_EMISSION]);
331 SCALE_3V(c_scene, mat[MAT_ATTRIB_FRONT_AMBIENT],
363 GLfloat (*mat)[4] = ctx->Light.Material.Attrib;
367 PUSH_DATAf(push, mat[MAT_ATTRIB_FRONT_DIFFUSE][3]);
425 float (*mat)[4] = ctx->Light.Material.Attrib;
429 CLAMP(mat[MAT_ATTRIB_FRONT_SHININESS][0], 0, 1024),
nv20_state_tnl.c 239 float (*mat)[4] = ctx->Light.Material.Attrib;
244 COPY_3V(c_scene, mat[MAT_ATTRIB_EMISSION(side)]);
248 SCALE_3V(c_scene, mat[MAT_ATTRIB_AMBIENT(side)],
281 GLfloat (*mat)[4] = ctx->Light.Material.Attrib;
285 PUSH_DATAf(push, mat[MAT_ATTRIB_DIFFUSE(side)][3]);
321 float (*mat)[4] = ctx->Light.Material.Attrib;
325 CLAMP(mat[MAT_ATTRIB_SHININESS(side)][0], 0, 1024),
  /external/mesa3d/src/mesa/drivers/dri/r200/
r200_state.c 986 GLfloat (*mat)[4] = ctx->Light.Material.Attrib;
999 fcmd[MTL_EMMISSIVE_RED] = mat[MAT_ATTRIB_FRONT_EMISSION][0];
1000 fcmd[MTL_EMMISSIVE_GREEN] = mat[MAT_ATTRIB_FRONT_EMISSION][1];
1001 fcmd[MTL_EMMISSIVE_BLUE] = mat[MAT_ATTRIB_FRONT_EMISSION][2];
1002 fcmd[MTL_EMMISSIVE_ALPHA] = mat[MAT_ATTRIB_FRONT_EMISSION][3];
1005 fcmd[MTL_AMBIENT_RED] = mat[MAT_ATTRIB_FRONT_AMBIENT][0];
1006 fcmd[MTL_AMBIENT_GREEN] = mat[MAT_ATTRIB_FRONT_AMBIENT][1];
1007 fcmd[MTL_AMBIENT_BLUE] = mat[MAT_ATTRIB_FRONT_AMBIENT][2];
1008 fcmd[MTL_AMBIENT_ALPHA] = mat[MAT_ATTRIB_FRONT_AMBIENT][3];
1011 fcmd[MTL_DIFFUSE_RED] = mat[MAT_ATTRIB_FRONT_DIFFUSE][0]
    [all...]
  /external/opencv3/modules/videoio/src/
cap_openni2.cpp 106 cv::Mat mat; member in struct:CvCapture_OpenNI2::OutputMap
142 cv::Mat depthImage, colorImage;
168 if( mat.empty() )
171 iplHeader = IplImage(mat);
718 inline void getDepthMapFromMetaData(const openni::VideoFrameRef& depthMetaData, cv::Mat& depthMap, int noSampleValue, int shadowValue)
723 cv::Mat badMask = (depthMap == (double)noSampleValue) | (depthMap == (double)shadowValue) | (depthMap == 0);
734 getDepthMapFromMetaData( depthFrame, outputMaps[CV_CAP_OPENNI_DEPTH_MAP].mat, noSampleValue, shadowValue );
744 cv::Mat depthImg;
750 cv::Mat pointCloud_XYZ( rows, cols, CV_32FC3, cv::Scalar::all(badPoint) )
    [all...]
  /external/eigen/Eigen/src/SparseCore/
SparseMatrix.h 872 InnerIterator(const SparseMatrix& mat, Index outer)
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];
    [all...]
  /external/mesa3d/src/gallium/state_trackers/vega/
shader.c 395 const struct matrix *mat)
397 shader->modelview = *mat;
403 void shader_set_paint_matrix(struct shader *shader, const struct matrix *mat)
408 memcpy(&shader->paint_matrix, mat, sizeof(*mat));
  /external/libgdx/extensions/gdx-bullet/jni/src/bullet/BulletDynamics/ConstraintSolver/
btGeneric6DofConstraint.cpp 72 btScalar btGetMatrixElem(const btMatrix3x3& mat, int index);
73 btScalar btGetMatrixElem(const btMatrix3x3& mat, int index)
77 return mat[i][j];
83 bool matrixToEulerXYZ(const btMatrix3x3& mat,btVector3& xyz);
84 bool matrixToEulerXYZ(const btMatrix3x3& mat,btVector3& xyz)
91 btScalar fi = btGetMatrixElem(mat,2);
96 xyz[0] = btAtan2(-btGetMatrixElem(mat,5),btGetMatrixElem(mat,8));
97 xyz[1] = btAsin(btGetMatrixElem(mat,2));
98 xyz[2] = btAtan2(-btGetMatrixElem(mat,1),btGetMatrixElem(mat,0))
    [all...]
  /external/opencv3/modules/cudaarithm/test/
test_element_operations.cpp 80 cv::Mat mat1 = randomMat(size, stype);
81 cv::Mat mat2 = randomMat(size, stype);
101 cv::Mat dst_gold(size, dtype, cv::Scalar::all(0));
141 cv::Mat mat1 = randomMat(size, stype);
142 cv::Mat mat2 = randomMat(size, stype);
143 cv::Mat mask = randomMat(size, CV_8UC1, 0, 2);
163 cv::Mat dst_gold(size, dtype, cv::Scalar::all(0));
199 cv::Mat mat = randomMat(size, depth.first); local
207 cv::cuda::add(loadMat(mat), val, dst, cv::cuda::GpuMat(), depth.second)
229 cv::Mat mat = randomMat(size, depth.first); local
287 cv::Mat mat = randomMat(size, depth.first); local
317 cv::Mat mat = randomMat(size, depth.first); local
502 cv::Mat mat = randomMat(size, depth.first); local
532 cv::Mat mat = randomMat(size, depth.first); local
590 cv::Mat mat = randomMat(size, depth.first); local
620 cv::Mat mat = randomMat(size, depth.first); local
871 cv::Mat mat = randomMat(size, depth.first); local
901 cv::Mat mat = randomMat(size, depth.first); local
958 cv::Mat mat = randomMat(size, depth.first); local
988 cv::Mat mat = randomMat(size, depth.first); local
1238 cv::Mat mat = randomMat(size, depth.first); local
1267 cv::Mat mat = randomMat(size, depth.first); local
1325 cv::Mat mat = randomMat(size, depth.first, 1.0, 255.0); local
    [all...]
  /external/opencv3/modules/core/include/opencv2/core/
core_c.h 246 @param mat A pointer to the matrix header to be initialized
254 CVAPI(CvMat*) cvInitMatHeader( CvMat* mat, int rows, int cols,
262 CvMat* mat = cvCreateMatHeader(rows, cols, type);
263 cvCreateData(mat);
279 if(*mat )
280 cvDecRefData(*mat);
281 cvFree((void**)mat);
283 @param mat Double pointer to the matrix
285 CVAPI(void) cvReleaseMat( CvMat** mat ); variable
302 CvMat* mat = (CvMat*)arr local
310 CvMatND* mat = (CvMatND*)arr; local
329 CvMat* mat = (CvMat*)arr; local
335 CvMatND* mat = (CvMatND*)arr; local
344 CVAPI(CvMat*) cvCloneMat( const CvMat* mat ); variable
481 CVAPI(CvMatND*) cvCloneMatND( const CvMatND* mat ); variable
499 CVAPI(void) cvReleaseSparseMat( CvSparseMat** mat ); variable
502 CVAPI(CvSparseMat*) cvCloneSparseMat( const CvSparseMat* mat ); variable
1359 CVAPI(double) cvDet( const CvArr* mat ); variable
1362 CVAPI(CvScalar) cvTrace( const CvArr* mat ); variable
    [all...]
  /external/opencv/cv/src/
cvlinefit.cpp 669 CvMat* mat = (CvMat*)array;
670 type = CV_MAT_TYPE(mat->type);
671 if( !CV_IS_MAT(mat))
674 if( !CV_IS_MAT_CONT(mat->type) ||
676 (mat->width != 1 && mat->height != 1))
681 CV_SEQ_KIND_GENERIC|type, sizeof(CvContour), CV_ELEM_SIZE(type), mat->data.ptr,
682 mat->width + mat->height - 1, &header.seq, &block ));
cvutils.cpp 56 CvMat* mat = (CvMat*)arr; local
58 if( !CV_IS_MAT( mat ))
61 eltype = CV_MAT_TYPE( mat->type );
67 if( (mat->width != 1 && mat->height != 1) || !CV_IS_MAT_CONT(mat->type))
74 sizeof(CvContour), CV_ELEM_SIZE(eltype), mat->data.ptr,
75 mat->width*mat->height, (CvSeq*)contour_header, block ));
  /external/opencv/cvaux/src/
cvhmmobs.cpp 610 CvMat stub, *mat = (CvMat*)arr; local
612 CV_CALL( mat = cvGetMat( arr, &stub ));
614 switch( CV_MAT_TYPE( mat->type ))
617 IPPI_CALL( icvImgToObs_DCT_8u32f_C1R( mat->data.ptr, mat->step,
618 cvGetMatSize(mat), obs,
622 IPPI_CALL( icvImgToObs_DCT_32f_C1R( mat->data.fl, mat->step,
623 cvGetMatSize(mat), obs,

Completed in 2960 milliseconds

1 2 3 4 5 6 7 891011>>