HomeSort by relevance Sort by last modified time
    Searched refs:Matrix (Results 576 - 600 of 946) sorted by null

<<21222324252627282930>>

  /frameworks/support/graphics/drawable/static/src/android/support/graphics/drawable/
VectorDrawableCompat.java 28 import android.graphics.Matrix;
236 private final Matrix mTmpMatrix = new Matrix();
299 float canvasScaleX = Math.abs(mTmpFloats[Matrix.MSCALE_X]);
300 float canvasScaleY = Math.abs(mTmpFloats[Matrix.MSCALE_Y]);
302 float canvasSkewX = Math.abs(mTmpFloats[Matrix.MSKEW_X]);
303 float canvasSkewY = Math.abs(mTmpFloats[Matrix.MSKEW_Y]);
803 Log.v(LOGTAG, indent + "matrix is :" + currentGroup.getLocalMatrix().toString());
    [all...]
  /external/eigen/Eigen/src/Core/util/
XprHelper.h 247 typedef Matrix<_Scalar, _Rows, _Cols, Options, _MaxRows, _MaxCols> type;
271 /* plain_matrix_type : the difference from eval is that plain_matrix_type is always a plain matrix type,
272 * whereas eval is a const reference in the case of a matrix
288 typedef Matrix<typename traits<T>::Scalar,
318 // typedef T::Matrix<typename traits<T>::Scalar,
334 struct eval<Matrix<_Scalar, _Rows, _Cols, _Options, _MaxRows, _MaxCols>, Dense>
336 typedef const Matrix<_Scalar, _Rows, _Cols, _Options, _MaxRows, _MaxCols>& type;
365 typedef Matrix<typename traits<T>::Scalar,
383 typedef Matrix<typename traits<T>::Scalar,
431 * many coefficient accesses in the nested expressions -- as is the case with matrix product for example
    [all...]
  /external/eigen/test/
sparse_solver.h 215 typedef Matrix<Scalar,Dynamic,Dynamic> DenseMatrix;
276 typedef Matrix<Scalar,Dynamic,Dynamic> DenseMatrix;
277 typedef Matrix<Scalar,Dynamic,1> DenseVector;
322 A = it.matrix();
358 typedef Matrix<Scalar,Dynamic,Dynamic> DenseMatrix;
405 typedef Matrix<Scalar,Dynamic,Dynamic> DenseMatrix;
406 typedef Matrix<Scalar,Dynamic,1> DenseVector;
453 A = it.matrix();
481 typedef Matrix<Scalar,Dynamic,Dynamic> DenseMatrix;
504 typedef Matrix<Scalar,Dynamic,Dynamic> DenseMatrix
    [all...]
product.h 26 typedef Matrix<Scalar, MatrixType::RowsAtCompileTime, 1> RowVectorType;
27 typedef Matrix<Scalar, MatrixType::ColsAtCompileTime, 1> ColVectorType;
28 typedef Matrix<Scalar, MatrixType::RowsAtCompileTime, MatrixType::RowsAtCompileTime> RowSquareMatrixType;
29 typedef Matrix<Scalar, MatrixType::ColsAtCompileTime, MatrixType::ColsAtCompileTime> ColSquareMatrixType;
30 typedef Matrix<Scalar, MatrixType::RowsAtCompileTime, MatrixType::ColsAtCompileTime,
135 // test submatrix and matrix/vector product
178 Matrix<Scalar,1,MatrixType::ColsAtCompileTime> w2(cols);
  /external/eigen/unsupported/Eigen/src/MatrixFunctions/
MatrixFunction.h 25 * \brief Helper class for computing matrix functions of atomic matrices.
27 * Here, an atomic matrix is a triangular matrix whose diagonal entries are close to each other.
38 * \param[in] f matrix function to compute.
42 /** \brief Compute matrix function of atomic matrix
43 * \param[in] A argument of matrix function, should be upper triangular and atomic
44 * \returns f(A), the matrix function evaluated at the given matrix
165 void matrix_function_compute_cluster_size(const ListOfClusters& clusters, Matrix<Index, Dynamic, 1>& clusterSize
    [all...]
  /external/swiftshader/src/Renderer/
VertexProcessor.cpp 217 void VertexProcessor::setModelMatrix(const Matrix &M, int i)
230 void VertexProcessor::setViewMatrix(const Matrix &V)
238 void VertexProcessor::setBaseMatrix(const Matrix &B)
246 void VertexProcessor::setProjectionMatrix(const Matrix &P)
498 void VertexProcessor::setTextureMatrix(int stage, const Matrix &T)
726 const Matrix &VertexProcessor::getModelTransform(int i)
732 const Matrix &VertexProcessor::getViewTransform()
743 void VertexProcessor::setTransform(const Matrix &M, int i)
766 void VertexProcessor::setCameraTransform(const Matrix &M, int i)
789 void VertexProcessor::setNormalTransform(const Matrix &M, int i
    [all...]
  /packages/apps/Gallery2/src/com/android/gallery3d/filtershow/crop/
CropActivity.java 30 import android.graphics.Matrix;
428 Matrix m = new Matrix();
450 Matrix m = new Matrix();
517 Matrix m = new Matrix();
524 m.setRectToRect(cropRect, returnRect, Matrix.ScaleToFit.FILL);
534 Matrix m = new Matrix();
    [all...]
  /external/eigen/Eigen/src/Core/
PermutationMatrix.h 29 * This class is the base class for all expressions representing a permutation matrix,
31 * The convention followed here is that if \f$ \sigma \f$ is a permutation, the corresponding permutation matrix
40 * operator* to multiply any kind of permutation object with any kind of matrix expression (MatrixBase)
62 typedef Matrix<StorageIndex,RowsAtCompileTime,ColsAtCompileTime,0,MaxRowsAtCompileTime,MaxColsAtCompileTime>
107 /** \returns the size of a side of the respective square matrix, i.e., the number of indices */
120 /** \returns a Matrix object initialized from this permutation matrix. Notice that it
121 * is inefficient to return this Matrix object by value. For efficiency, favor using
122 * the Matrix constructor taking EigenBase objects.
141 /** Sets *this to be the identity permutation matrix */
    [all...]
DiagonalMatrix.h 36 typedef Matrix<Scalar, RowsAtCompileTime, ColsAtCompileTime, 0, MaxRowsAtCompileTime, MaxColsAtCompileTime> DenseMatrixType;
61 operator*(const MatrixBase<MatrixDerived> &matrix) const
63 return Product<Derived, MatrixDerived, LazyProduct>(derived(),matrix.derived());
93 * \brief Represents a diagonal matrix with its storage
96 * \param SizeAtCompileTime the dimension of the matrix, or Dynamic
97 * \param MaxSizeAtCompileTime the dimension of the matrix, or Dynamic. This parameter is optional and defaults
106 : traits<Matrix<_Scalar,SizeAtCompileTime,SizeAtCompileTime,0,MaxSizeAtCompileTime,MaxSizeAtCompileTime> >
108 typedef Matrix<_Scalar,SizeAtCompileTime,1,0,MaxSizeAtCompileTime,1> DiagonalVectorType;
145 /** Constructs a diagonal matrix with given dimension */
203 /** Sets this matrix to be the identity matrix of the current size. *
    [all...]
  /external/eigen/Eigen/src/Eigenvalues/
RealSchur.h 23 * \brief Performs a real Schur decomposition of a square matrix
25 * \tparam _MatrixType the type of the matrix of which we are computing the
27 * Matrix class template.
29 * Given a real square matrix A, this class computes the real Schur
30 * decomposition: \f$ A = U T U^T \f$ where U is a real orthogonal matrix and
31 * T is a real quasi-triangular matrix. An orthogonal matrix is a matrix whose
33 * matrix is a block-triangular matrix whose diagonal consists of 1-by-
    [all...]
  /external/eigen/unsupported/Eigen/src/IterativeSolvers/
DGMRES.h 70 * at right of the matrix and the combination is multiplicative.
72 * \tparam _MatrixType the type of the sparse matrix A, can be a dense or a sparse matrix.
86 * DGMRES can also be used in a matrix-free context, see the following \link MatrixfreeSolverExample example \endlink.
105 using Base::matrix;
119 typedef Matrix<Scalar,Dynamic,Dynamic> DenseMatrix;
120 typedef Matrix<RealScalar,Dynamic,Dynamic> DenseRealMatrix;
121 typedef Matrix<Scalar,Dynamic,1> DenseVector;
122 typedef Matrix<RealScalar,Dynamic,1> DenseRealVector;
123 typedef Matrix<std::complex<RealScalar>, Dynamic, 1> ComplexVector
    [all...]
  /frameworks/base/packages/EasterEgg/src/com/android/egg/octo/
OctopusDrawable.java 22 import android.graphics.Matrix;
52 final Matrix M = new Matrix();
53 final Matrix M_inv = new Matrix();
273 static void mapPointF(Matrix m, PointF point) {
  /prebuilts/gcc/linux-x86/host/x86_64-w64-mingw32-4.8/x86_64-w64-mingw32/include/gdiplus/
gdiplusbrush.h 291 Status GetTransform(Matrix *matrix) const
295 matrix ? matrix->nativeMatrix : NULL));
304 Status MultiplyTransform(const Matrix *matrix,
309 matrix ? matrix->nativeMatrix : NULL, order));
378 Status SetTransform(const Matrix *matrix)
    [all...]
  /external/deqp/modules/glshared/
glsLongStressCase.hpp 91 void set (const tcu::Matrix<float, ValRows, ValCols>& minValue_, const tcu::Matrix<float, ValRows, ValCols>& maxValue_)
123 static inline void matToArr (const tcu::Matrix<float, ValRows, ValCols>& src, float (&dst)[DstSize])
  /external/eigen/Eigen/src/QR/
HouseholderQR.h 22 * \brief Householder QR decomposition of a matrix
24 * \tparam _MatrixType the type of the matrix of which we are computing the QR decomposition
26 * This class performs a QR decomposition of a matrix \b A into matrices \b Q and \b R
31 * by using Householder transformations. Here, \b Q a unitary matrix and \b R an upper triangular matrix.
59 typedef Matrix<Scalar, RowsAtCompileTime, RowsAtCompileTime, (MatrixType::Flags&RowMajorBit) ? RowMajor : ColMajor, MaxRowsAtCompileTime, MaxRowsAtCompileTime> MatrixQType;
84 /** \brief Constructs a QR factorization from a given matrix
86 * This constructor computes the QR factorization of the matrix \a matrix by calling
90 * HouseholderQR<MatrixType> qr(matrix.rows(), matrix.cols())
    [all...]
  /external/eigen/bench/btl/libs/eigen3/
eigen3_interface.hh 40 typedef Eigen::Matrix<real,SIZE,SIZE> gene_matrix;
41 typedef Eigen::Matrix<real,SIZE,1> gene_vector;
219 Matrix<DenseIndex,1,Dynamic> piv(N);
  /frameworks/base/packages/WallpaperCropper/src/com/android/photos/views/
TiledImageView.java 25 import android.graphics.Matrix;
245 public void positionFromMatrix(Matrix matrix) {
257 matrix.mapRect(mTempRectF);
258 matrix.getValues(mValues);
261 float scale = mValues[Matrix.MSCALE_X];
  /frameworks/base/tests/HwAccelerationTest/src/com/android/test/hwui/
GradientsActivity.java 27 import android.graphics.Matrix;
197 private final Matrix mMatrix;
209 mMatrix = new Matrix();
  /frameworks/rs/tests/java_api/LivePreview/src/com/android/rs/livepreview/
CameraPreviewActivity.java 28 import android.graphics.Matrix;
271 Matrix transform = new Matrix();
  /packages/apps/Camera2/src/com/android/camera/
CaptureLayoutHelper.java 20 import android.graphics.Matrix;
351 Matrix rotate = new Matrix();
MultiToggleImageButton.java 27 import android.graphics.Matrix;
75 private Matrix mMatrix = new Matrix();
260 setScaleType(ImageView.ScaleType.MATRIX);
  /packages/apps/Gallery2/src/com/android/gallery3d/filtershow/imageshow/
GradControl.java 24 import android.graphics.Matrix;
51 private Matrix mScrToImg;
119 public void setScrImageInfo(Matrix scrToImg, Rect imageBounds) {
147 // Test if the matrix is swapping x and y
  /packages/apps/Gallery2/src/com/android/gallery3d/ingest/ui/
MtpImageView.java 27 import android.graphics.Matrix;
122 private Matrix mDrawMatrix = new Matrix();
187 if (changed && getScaleType() == ScaleType.MATRIX) {
205 if (getScaleType() == ScaleType.MATRIX) {
  /packages/apps/Gallery2/src/com/android/photos/views/
TiledImageView.java 25 import android.graphics.Matrix;
245 public void positionFromMatrix(Matrix matrix) {
257 matrix.mapRect(mTempRectF);
258 matrix.getValues(mValues);
261 float scale = mValues[Matrix.MSCALE_X];
  /packages/apps/Launcher2/src/com/android/launcher2/
WallpaperChooserDialogFragment.java 29 import android.graphics.Matrix;
323 Matrix mMatrix;
354 mMatrix = new Matrix();

Completed in 1329 milliseconds

<<21222324252627282930>>