/external/eigen/test/ |
basicstuff.cpp | 18 typedef Matrix<Scalar, MatrixType::RowsAtCompileTime, 1> VectorType; 19 typedef Matrix<Scalar, MatrixType::RowsAtCompileTime, MatrixType::RowsAtCompileTime> SquareMatrixType; 30 square = Matrix<Scalar, MatrixType::RowsAtCompileTime, MatrixType::RowsAtCompileTime>::Random(rows, rows); 74 Matrix<Scalar, 1, MatrixType::RowsAtCompileTime> rv(rows); 75 Matrix<Scalar, MatrixType::RowsAtCompileTime, 1> cv(rows); 150 typedef Matrix<RealScalar, MatrixType::RowsAtCompileTime, MatrixType::ColsAtCompileTime> RealMatrixType; 202 Matrix<Scalar,4,1> m(raw); 206 VERIFY_IS_EQUAL(m,(Matrix<Scalar,4,1>(raw[0],raw[1],raw[2],raw[3]))); 210 Matrix<Scalar,3,1> m(raw); 214 VERIFY_IS_EQUAL(m,(Matrix<Scalar,3,1>(raw[0],raw[1],raw[2]))) [all...] |
qr_fullpivoting.cpp | 26 typedef Matrix<Scalar, MatrixType::RowsAtCompileTime, MatrixType::RowsAtCompileTime> MatrixQType; 87 // let's build a matrix more stable to inverse 101 // now construct a matrix with prescribed determinant 155 CALL_SUBTEST_7((FullPivHouseholderQR<Matrix<float,10,20> >(10,20))); 156 CALL_SUBTEST_7((FullPivHouseholderQR<Matrix<float,10,20> >(Matrix<float,10,20>::Random()))); 157 CALL_SUBTEST_7((FullPivHouseholderQR<Matrix<float,20,10> >(20,10))); 158 CALL_SUBTEST_7((FullPivHouseholderQR<Matrix<float,20,10> >(Matrix<float,20,10>::Random())));
|
diagonalmatrices.cpp | 17 typedef Matrix<Scalar, Rows, 1> VectorType; 18 typedef Matrix<Scalar, 1, Cols> RowVectorType; 19 typedef Matrix<Scalar, Rows, Rows> SquareMatrixType; 20 typedef Matrix<Scalar, Dynamic, Dynamic> DynMatrixType; 23 typedef Matrix<Scalar, Rows==Dynamic?Dynamic:2*Rows, Cols==Dynamic?Dynamic:2*Cols> BigMatrix; 118 CALL_SUBTEST_1( diagonalmatrices(Matrix<float, 1, 1>()) ); 120 CALL_SUBTEST_3( diagonalmatrices(Matrix<double,3,3,RowMajor>()) ); 122 CALL_SUBTEST_5( diagonalmatrices(Matrix<float,4,4,RowMajor>()) ); 125 CALL_SUBTEST_8( diagonalmatrices(Matrix<double,Dynamic,Dynamic,RowMajor>(internal::random<int>(1,EIGEN_TEST_MAX_SIZE), internal::random<int>(1,EIGEN_TEST_MAX_SIZE))) );
|
ref.cpp | 38 typedef Matrix<Scalar,Dynamic,Dynamic,MatrixType::Options> DynMatrixType; 39 typedef Matrix<RealScalar,Dynamic,Dynamic,MatrixType::Options> RealDynMatrixType; 86 typedef Matrix<Scalar,Dynamic,1,VectorType::Options> DynMatrixType; 87 typedef Matrix<Scalar,Dynamic,Dynamic,ColMajor> MatrixType; 88 typedef Matrix<RealScalar,Dynamic,1,VectorType::Options> RealDynMatrixType; 165 EIGEN_DONT_INLINE void call_ref_7(Ref<Matrix<float,Dynamic,3> > a, const B &b) { VERIFY_IS_EQUAL(a,b); } 217 VERIFY_EVALUATION_COUNT( call_ref_6(A.row(3),A.row(3)), 1); // evaluated into a temp thouth it could be avoided by viewing it as a 1xn matrix 227 typedef Matrix<double,Dynamic,Dynamic,RowMajor> RowMatrixXd; 261 CALL_SUBTEST_1( ref_vector(Matrix<float, 1, 1>()) ); 262 CALL_SUBTEST_1( check_const_correctness(Matrix<float, 1, 1>()) ) [all...] |
/packages/apps/Gallery2/src/com/android/gallery3d/filtershow/imageshow/ |
GeometryMathUtils.java | 21 import android.graphics.Matrix; 217 private static void concatMirrorMatrix(Matrix m, GeometryHolder holder) { 317 Matrix m = getCropSelectionToScreenMatrix(null, holder, width, height, frame.width(), 331 public static Matrix getImageToScreenMatrix(Collection<FilterRepresentation> geometry, 338 public static Matrix getPartialToScreenMatrix(Collection<FilterRepresentation> geometry, 349 Matrix compensation = new Matrix(); 372 public static Matrix getOriginalToScreen(GeometryHolder holder, boolean rotate, 380 Matrix m = getCropSelectionToScreenMatrix(null, holder, (int) originalWidth, 407 Matrix m = getCropSelectionToScreenMatrix(crop, holder, photo.getWidth(), photo.getHeight() [all...] |
/cts/apps/CtsVerifier/src/com/android/cts/verifier/sensors/sixdof/Renderer/ |
ComplexMovementRenderer.java | 34 import android.opengl.Matrix; 122 // Update the MV matrix with new pose data. 135 // Set up projection matrix to match camera intrinsics. 137 // Set up view matrix to match current device positioning. 221 * Update the view matrix of the Renderer to follow the position of the device in the current 226 Matrix.setIdentityM(invertModelMat, 0); 229 Matrix.setIdentityM(temporaryMatrix, 0); 231 Matrix.setIdentityM(mPoseViewMatrix, 0); 232 Matrix.invertM(invertModelMat, 0, 234 Matrix.multiplyMM(temporaryMatrix, 0, mPoseViewMatrix, 0 [all...] |
/cts/tests/tests/graphics/src/android/graphics/cts/ |
ComposeShaderTest.java | 27 import android.graphics.Matrix; 105 Matrix translate1x1 = new Matrix(); 107 Matrix translate0x1 = new Matrix(); 109 Matrix translate1x0 = new Matrix();
|
CanvasTest.java | 36 import android.graphics.Matrix; 210 final Matrix m1 = new Matrix(); 215 final Matrix m2 = new Matrix(); 220 final Matrix m3 = mCanvas.getMatrix(); 227 final Matrix m4 = mCanvas.getMatrix(); 239 Matrix m1 = new Matrix(); 244 Matrix m2 = new Matrix() [all...] |
/external/eigen/unsupported/test/ |
EulerAngles.cpp | 17 void verify_euler_ranged(const Matrix<Scalar,3,1>& ea, 21 typedef Matrix<Scalar,3,3> Matrix3; 22 typedef Matrix<Scalar,3,1> Vector3; 125 void verify_euler(const Matrix<Scalar,3,1>& ea) 137 template<typename Scalar> void check_all_var(const Matrix<Scalar,3,1>& ea) 157 typedef Matrix<Scalar,3,3> Matrix3; 158 typedef Matrix<Scalar,3,1> Vector3;
|
matrix_power.cpp | 15 Matrix<T,2,2> A, B, C; 19 MatrixPower<Matrix<T,2,2> > Apow(A); 36 Matrix<std::complex<T>,2,2> A, B, C; 41 MatrixPower<Matrix<std::complex<T>,2,2> > Apow(A); 58 Matrix<T,3,1> v; 62 v = Matrix<T,3,1>::Random(); 65 VERIFY(AngleAxis<T>(angle, v).matrix().isApprox(AngleAxis<T>(1,v).matrix().pow(angle), tol)); 149 typedef Matrix<double,3,3,RowMajor> Matrix3dRowMajor; 150 typedef Matrix<long double,3,3> Matrix3e [all...] |
NumericalDiff.cpp | 20 typedef Matrix<Scalar,InputsAtCompileTime,1> InputType; 21 typedef Matrix<Scalar,ValuesAtCompileTime,1> ValueType; 22 typedef Matrix<Scalar,ValuesAtCompileTime,InputsAtCompileTime> JacobianType;
|
autodiff_scalar.cpp | 20 typedef Matrix<Scalar, 1, 1> Deriv1; 44 typedef Matrix<Scalar, 1, 1> Deriv1; 78 typedef Eigen::Matrix<Scalar, 1, 1> Deriv;
|
/frameworks/base/tests/CanvasCompare/src/com/android/test/hwuicompare/ |
ResourceModifiers.java | 31 import android.graphics.Matrix; 51 private final Matrix mMtx1; 52 private final Matrix mMtx2; 53 private final Matrix mMtx3; 77 mMtx1 = new Matrix(); 84 mMtx2 = new Matrix(); 90 mMtx3 = new Matrix();
|
/frameworks/support/compat/src/main/java/androidx/core/app/ |
SharedElementCallback.java | 21 import android.graphics.Matrix; 43 private Matrix mTempMatrix; 157 * @param viewToGlobalMatrix A matrix containing a transform from the view to the screen 166 public Parcelable onCaptureSharedElementSnapshot(View sharedElement, Matrix viewToGlobalMatrix, 179 if (imageView.getScaleType() == ScaleType.MATRIX) { 180 Matrix matrix = imageView.getImageMatrix(); local 182 matrix.getValues(values); 197 mTempMatrix = new Matrix(); 241 * {@link #onCaptureSharedElementSnapshot(android.view.View, android.graphics.Matrix, 271 Matrix matrix = new Matrix(); local [all...] |
/external/eigen/Eigen/src/Eigenvalues/ |
GeneralizedEigenSolver.h | 27 * eigen-decomposition; this is expected to be an instantiation of the Matrix 30 * The generalized eigenvalues and eigenvectors of a matrix pair \f$ A \f$ and \f$ B \f$ are scalars 32 * \f$ D \f$ is a diagonal matrix with the eigenvalues on the diagonal, and 33 * \f$ V \f$ is a matrix with the eigenvectors as its columns, then \f$ A V = 34 * B V D \f$. The matrix \f$ V \f$ is almost always invertible, in which case we 37 * The generalized eigenvalues and eigenvectors of a matrix pair may be complex, even when the 38 * matrices are real. Moreover, the generalized eigenvalue might be infinite if the matrix B is 46 * a given matrix pair. Alternatively, you can use the 91 typedef Matrix<Scalar, ColsAtCompileTime, 1, Options & ~RowMajor, MaxColsAtCompileTime, 1> VectorType; 98 typedef Matrix<ComplexScalar, ColsAtCompileTime, 1, Options & ~RowMajor, MaxColsAtCompileTime, 1> ComplexVectorTy (…) [all...] |
/external/eigen/Eigen/src/Geometry/ |
EulerAngles.h | 18 * \returns the Euler-angles of the rotation matrix \c *this using the convention defined by the triplet (\a a0,\a a1,\a a2) 36 EIGEN_DEVICE_FUNC inline Matrix<typename MatrixBase<Derived>::Scalar,3,1> 45 Matrix<Scalar,3,1> res; 46 typedef Matrix<typename Derived::Scalar,2,1> Vector2;
|
/external/eigen/Eigen/src/QR/ |
ColPivHouseholderQR_LAPACKE.h | 29 * Householder QR decomposition of a matrix with column pivoting based on 43 ColPivHouseholderQR<Matrix<EIGTYPE, Dynamic, Dynamic, EIGCOLROW, Dynamic, Dynamic> >& \ 44 ColPivHouseholderQR<Matrix<EIGTYPE, Dynamic, Dynamic, EIGCOLROW, Dynamic, Dynamic> >::compute( \ 45 const EigenBase<InputType>& matrix) \ 49 typedef Matrix<EIGTYPE, Dynamic, Dynamic, EIGCOLROW, Dynamic, Dynamic> MatrixType; \ 51 Index rows = matrix.rows();\ 52 Index cols = matrix.cols();\ 54 m_qr = matrix;\
|
/external/eigen/Eigen/src/SVD/ |
UpperBidiagonalization.h | 33 typedef Matrix<Scalar, 1, ColsAtCompileTime> RowVectorType; 34 typedef Matrix<Scalar, RowsAtCompileTime, 1> ColVectorType; 36 typedef Matrix<Scalar, ColsAtCompileTime, 1> DiagVectorType; 37 typedef Matrix<Scalar, ColsAtCompileTimeMinusOne, 1> SuperDiagVectorType; 56 explicit UpperBidiagonalization(const MatrixType& matrix) 57 : m_householder(matrix.rows(), matrix.cols()), 58 m_bidiagonal(matrix.cols(), matrix.cols()), 61 compute(matrix); [all...] |
/external/eigen/bench/perf_monitoring/gemm/ |
lazy_gemm.cpp | 28 typedef Matrix<Scalar,m,k,TA> MatA; 29 typedef Matrix<Scalar,k,n> MatB; 30 typedef Matrix<Scalar,m,n> MatC;
|
/external/llvm/lib/CodeGen/ |
RegAllocBase.cpp | 61 Matrix = &mat; 97 Matrix->invalidateVirtRegs(); 133 Matrix->assign(*VirtReg, AvailablePhysReg);
|
/external/swiftshader/src/Renderer/ |
Point.cpp | 17 #include "Matrix.hpp" 54 Point operator*(const Matrix &M, const Point &P) 61 Point operator*(const Point &P, const Matrix &M) 68 Point &operator*=(Point &P, const Matrix &M)
|
/external/tensorflow/tensorflow/core/kernels/ |
gemm_functors.h | 16 // This is a set of different implementations for the basic matrix by matrix 50 // A readable but slow implementation of matrix multiplication, useful for 84 // Uses the optimized EigenTensor library to implement the matrix multiplication 94 typename tensorflow::TTypes<const T1>::Matrix a_matrix(a, m, k); 95 typename tensorflow::TTypes<const T2>::Matrix b_matrix(b, k, n); 96 typename tensorflow::TTypes<T3>::Matrix c_matrix(c, m, n);
|
svd_op_impl.h | 76 using Matrix = typename Base::Matrix; 88 Eigen::BDCSVD<Matrix> svd(inputs[0], options);
|
/frameworks/base/core/java/android/transition/ |
PatternPathMotion.java | 20 import android.graphics.Matrix; 45 private final Matrix mTempMatrix = new Matrix();
|
/frameworks/base/core/java/com/android/internal/util/ |
ImageUtils.java | 22 import android.graphics.Matrix; 48 private final Matrix mTempMatrix = new Matrix();
|