HomeSort by relevance Sort by last modified time
    Searched full:matrix (Results 676 - 700 of 3296) sorted by null

<<21222324252627282930>>

  /packages/apps/Gallery2/src/com/android/gallery3d/filtershow/crop/
BoundedRect.java 18 import android.graphics.Matrix;
114 Matrix m0 = getInverseRotMatrix();
177 Matrix m = getRotMatrix();
178 Matrix m0 = getInverseRotMatrix();
246 Matrix m = getRotMatrix();
247 Matrix m0 = getInverseRotMatrix();
346 Matrix m = getRotMatrix();
353 Matrix m = getInverseRotMatrix();
357 private Matrix getRotMatrix() {
358 Matrix m = new Matrix()
    [all...]
  /external/ceres-solver/internal/ceres/
rotation_test.cc 150 // double matrix[9];
151 // EXPECT_THAT(matrix, IsOrthonormal());
154 *result_listener << "Null matrix";
183 *result_listener << "Null matrix";
370 // Transforms a zero axis/angle to a rotation matrix.
373 double matrix[9]; local
375 AngleAxisToRotationMatrix(axis_angle, matrix);
376 EXPECT_THAT(matrix, IsOrthonormal());
377 EXPECT_THAT(matrix, IsNear3x3Matrix(expected));
382 double matrix[9] local
392 double matrix[9]; local
407 double matrix[9]; local
420 double matrix[9]; local
504 double matrix[9]; local
539 double matrix[9]; local
    [all...]
  /external/eigen/Eigen/src/SuperLUSupport/
SuperLUSupport.h 199 eigen_assert(((MatrixType::Flags & SelfAdjoint)==0) && "SelfAdjoint matrix shape not supported by SuperLU");
206 struct SluMatrixMapHelper<Matrix<Scalar,Rows,Cols,Options,MRows,MCols> >
208 typedef Matrix<Scalar,Rows,Cols,Options,MRows,MCols> MatrixType;
258 eigen_assert(((MatrixType::Flags & SelfAdjoint)==0) && "SelfAdjoint matrix shape not supported by SuperLU");
270 /** View a Super LU matrix as an Eigen expression */
298 typedef Matrix<Scalar,Dynamic,1> Vector;
299 typedef Matrix<int, 1, MatrixType::ColsAtCompileTime> IntRowVectorType;
300 typedef Matrix<int, MatrixType::RowsAtCompileTime, 1> IntColVectorType;
324 * \c NumericalIssue if the matrix.appears to be negative.
332 /** Computes the sparse Cholesky decomposition of \a matrix */
    [all...]
  /cts/suite/cts/deviceTests/simplecpu/src/com/android/cts/simplecpu/
SimpleCpuTest.java 31 * matrix multiplication (for floating point performance)
113 * Matrix multiplication test, nxn matrix multiplication
124 getReportLog().printArray("matrix mutiplication time", result, ResultType.LOWER_BETTER,
130 getReportLog().printSummary("matrix mutiplication time", stat.mAverage,
  /external/ceres-solver/include/ceres/
crs_matrix.h 39 // A compressed row sparse matrix used primarily for communicating the
40 // Jacobian matrix to the user.
47 // A compressed row matrix stores its contents in three arrays,
60 // the matrix.
62 // e.g, consider the 3x4 sparse matrix
  /external/chromium_org/third_party/WebKit/Source/core/platform/graphics/transforms/
MatrixTransformOperation.h 45 TransformationMatrix matrix() const { return TransformationMatrix(m_a, m_b, m_c, m_d, m_e, m_f); } function in class:WebCore::MatrixTransformOperation
50 virtual OperationType getOperationType() const { return Matrix; }
51 virtual bool isSameType(const TransformOperation& o) const { return o.getOperationType() == Matrix; }
64 TransformationMatrix matrix(m_a, m_b, m_c, m_d, m_e, m_f);
65 transform.multiply(matrix);
  /external/chromium_org/third_party/WebKit/Source/core/svg/
SVGGraphicsElement.cpp 65 AffineTransform matrix; local
76 matrix = transform.toAffineTransform();
78 transformCurrentValue().concatenate(matrix);
82 return *m_supplementalTransform * matrix;
83 return matrix;
  /external/chromium_org/third_party/angle_dx11/samples/gles2_book/Simple_VertexShader/
Simple_VertexShader.c 38 // MVP matrix
85 // Update MVP matrix based on time
102 // Generate a perspective matrix with a 60 degree FOV
106 // Generate a model view matrix to rotate/translate the cube
144 // Load the MVP matrix
  /external/chromium_org/third_party/skia/src/core/
SkPictureStateTree.h 32 * A draw call, stores offset into command buffer, a pointer to the matrix, and a pointer to
54 * of offsets into the command buffer to carry out those calls with correct matrix/clip state.
55 * This handles saves/restores, and does all necessary matrix setup.
96 // The matrix of the canvas we're playing back into
99 // Cache of current matrix, so we can avoid redundantly setting it
  /external/chromium_org/third_party/skia/src/gpu/
GrPathUtils.h 55 // A 2x3 matrix that goes from the 2d space coordinates to UV space where
56 // u^2-v = 0 specifies the quad. The matrix is determined by the control
61 // Initialize the matrix from the control pts
66 * Applies the matrix to vertex positions to compute UV coords. This
102 // use tolScale = 1, otherwise set based on stretchiness of the matrix. The
  /external/eigen/Eigen/src/Cholesky/
LLT.h 23 * \brief Standard Cholesky decomposition (LL^T) of a matrix and associated features
25 * \param MatrixType the type of the matrix of which we are computing the LL^T Cholesky decomposition
30 * matrix A such that A = LL^* = U^*U, where L is lower triangular.
89 LLT(const MatrixType& matrix)
90 : m_matrix(matrix.rows(), matrix.cols()),
93 compute(matrix);
96 /** \returns a view of the upper triangular matrix U */
103 /** \returns a view of the lower triangular matrix L */
112 * Since this LLT class assumes anyway that the matrix A is invertible, the solutio
    [all...]
  /external/eigen/Eigen/src/Householder/
HouseholderSequence.h 20 * \tparam VectorsType type of matrix containing the Householder vectors
29 * are used in several algorithms to zero out certain parts of a matrix. Indeed, the methods
33 * More precisely, the class %HouseholderSequence represents an \f$ n \times n \f$ matrix \f$ H \f$ of the
48 * MatrixXd Q = H; // conversion to a dense matrix
106 typedef Matrix<ResultScalar, MatrixType::RowsAtCompileTime, MatrixType::ColsAtCompileTime,
138 * \param[in] v %Matrix containing the essential parts of the Householder vectors
170 /** \brief Number of rows of transformation viewed as a matrix.
176 /** \brief Number of columns of transformation viewed as a matrix.
191 * The index \f$ i \f$ equals \p k + shift(), corresponding to the k-th column of the matrix \p v
229 Matrix<Scalar, DestType::RowsAtCompileTime, 1
    [all...]
  /external/eigen/blas/
BandTriangularSolver.h 16 * Solve Ax=b with A a band triangular matrix
25 typedef Map<const Matrix<LhsScalar,Dynamic,Dynamic,RowMajor>, 0, OuterStride<> > LhsMap;
26 typedef Map<Matrix<RhsScalar,Dynamic,1> > RhsMap;
61 typedef Map<const Matrix<LhsScalar,Dynamic,Dynamic,ColMajor>, 0, OuterStride<> > LhsMap;
62 typedef Map<Matrix<RhsScalar,Dynamic,1> > RhsMap;
ctbmv.f 13 * CTBMV performs one of the matrix-vector operations
18 * upper or lower triangular band matrix, with ( k + 1 ) diagonals.
24 * On entry, UPLO specifies whether the matrix is an upper or
25 * lower triangular matrix as follows:
27 * UPLO = 'U' or 'u' A is an upper triangular matrix.
29 * UPLO = 'L' or 'l' A is a lower triangular matrix.
57 * On entry, N specifies the order of the matrix A.
63 * super-diagonals of the matrix A.
65 * sub-diagonals of the matrix A.
72 * band part of the matrix of coefficients, supplied column b
    [all...]
dtbmv.f 13 * DTBMV performs one of the matrix-vector operations
18 * upper or lower triangular band matrix, with ( k + 1 ) diagonals.
24 * On entry, UPLO specifies whether the matrix is an upper or
25 * lower triangular matrix as follows:
27 * UPLO = 'U' or 'u' A is an upper triangular matrix.
29 * UPLO = 'L' or 'l' A is a lower triangular matrix.
57 * On entry, N specifies the order of the matrix A.
63 * super-diagonals of the matrix A.
65 * sub-diagonals of the matrix A.
72 * band part of the matrix of coefficients, supplied column b
    [all...]
stbmv.f 13 * STBMV performs one of the matrix-vector operations
18 * upper or lower triangular band matrix, with ( k + 1 ) diagonals.
24 * On entry, UPLO specifies whether the matrix is an upper or
25 * lower triangular matrix as follows:
27 * UPLO = 'U' or 'u' A is an upper triangular matrix.
29 * UPLO = 'L' or 'l' A is a lower triangular matrix.
57 * On entry, N specifies the order of the matrix A.
63 * super-diagonals of the matrix A.
65 * sub-diagonals of the matrix A.
72 * band part of the matrix of coefficients, supplied column b
    [all...]
ztbmv.f 13 * ZTBMV performs one of the matrix-vector operations
18 * upper or lower triangular band matrix, with ( k + 1 ) diagonals.
24 * On entry, UPLO specifies whether the matrix is an upper or
25 * lower triangular matrix as follows:
27 * UPLO = 'U' or 'u' A is an upper triangular matrix.
29 * UPLO = 'L' or 'l' A is a lower triangular matrix.
57 * On entry, N specifies the order of the matrix A.
63 * super-diagonals of the matrix A.
65 * sub-diagonals of the matrix A.
72 * band part of the matrix of coefficients, supplied column b
    [all...]
  /external/eigen/test/eigen2/
eigen2_adjoint.cpp 20 typedef Matrix<Scalar, MatrixType::RowsAtCompileTime, 1> VectorType;
21 typedef Matrix<Scalar, MatrixType::RowsAtCompileTime, MatrixType::RowsAtCompileTime> SquareMatrixType;
91 CALL_SUBTEST_1( adjoint(Matrix<float, 1, 1>()) );
98 // test a large matrix only once
99 CALL_SUBTEST_7( adjoint(Matrix<float, 100, 100>()) );
  /external/eigen/test/
eigensolver_complex.cpp 44 typedef Matrix<Scalar, MatrixType::RowsAtCompileTime, 1> VectorType;
45 typedef Matrix<RealScalar, MatrixType::RowsAtCompileTime, 1> RealVectorType;
76 // Test matrix with NaN
101 CALL_SUBTEST_3( eigensolver(Matrix<std::complex<float>, 1, 1>()) );
108 CALL_SUBTEST_3( eigensolver_verify_assert(Matrix<std::complex<float>, 1, 1>()) );
eigensolver_generic.cpp 26 typedef Matrix<Scalar, MatrixType::RowsAtCompileTime, 1> VectorType;
27 typedef Matrix<RealScalar, MatrixType::RowsAtCompileTime, 1> RealVectorType;
58 // Test matrix with NaN
90 CALL_SUBTEST_3( eigensolver(Matrix<double,1,1>()) );
97 CALL_SUBTEST_3( eigensolver_verify_assert(Matrix<double,1,1>()) );
product_trsolve.cpp 34 Matrix<Scalar,Size,Size,ColMajor> cmLhs(size,size);
35 Matrix<Scalar,Size,Size,RowMajor> rmLhs(size,size);
39 Matrix<Scalar,Size,Cols,colmajor> cmRhs(size,cols);
40 Matrix<Scalar,Size,Cols,rowmajor> rmRhs(size,cols);
41 Matrix<Scalar,Dynamic,Dynamic,colmajor> ref(size,cols);
  /external/eigen/unsupported/Eigen/src/NonLinearOptimization/
dogleg.h 7 const Matrix< Scalar, Dynamic, Dynamic > &qrfac,
8 const Matrix< Scalar, Dynamic, 1 > &diag,
9 const Matrix< Scalar, Dynamic, 1 > &qtb,
11 Matrix< Scalar, Dynamic, 1 > &x)
27 Matrix< Scalar, Dynamic, 1 > wa1(n), wa2(n);
  /external/skia/src/core/
SkPictureStateTree.h 32 * A draw call, stores offset into command buffer, a pointer to the matrix, and a pointer to
54 * of offsets into the command buffer to carry out those calls with correct matrix/clip state.
55 * This handles saves/restores, and does all necessary matrix setup.
96 // The matrix of the canvas we're playing back into
99 // Cache of current matrix, so we can avoid redundantly setting it
  /external/skia/src/gpu/
GrPathUtils.h 55 // A 2x3 matrix that goes from the 2d space coordinates to UV space where
56 // u^2-v = 0 specifies the quad. The matrix is determined by the control
61 // Initialize the matrix from the control pts
66 * Applies the matrix to vertex positions to compute UV coords. This
102 // use tolScale = 1, otherwise set based on stretchiness of the matrix. The
  /external/skia/tests/
Matrix44Test.cpp 81 // Allocate a matrix on the heap
93 // constructor did avoid initializing the matrix contents.
103 // Verify that kIdentity_Constructor really does initialize to an identity matrix.
213 SkMatrix44 matrix; local
215 REPORTER_ASSERT(reporter, matrix.isIdentity());
216 REPORTER_ASSERT(reporter, SkMatrix44::kIdentity_Mask == matrix.getType());
220 matrix.set(1, 1, 0);
222 REPORTER_ASSERT(reporter, matrix.getType() == expectedMask);
224 matrix.set(0, 3, 1); // translate-x
226 REPORTER_ASSERT(reporter, matrix.getType() == expectedMask)
    [all...]

Completed in 656 milliseconds

<<21222324252627282930>>