HomeSort by relevance Sort by last modified time
    Searched refs:Matrix (Results 301 - 325 of 703) sorted by null

<<11121314151617181920>>

  /external/eigen/test/eigen2/
eigen2_sparse_vector.cpp 16 typedef Matrix<Scalar,Dynamic,Dynamic> DenseMatrix;
17 typedef Matrix<Scalar,Dynamic,1> DenseVector;
eigen2_swap.cpp 20 struct other_matrix_type<Matrix<_Scalar, _Rows, _Cols, _Options, _MaxRows, _MaxCols> >
22 typedef Matrix<_Scalar, _Rows, _Cols, _Options^RowMajor, _MaxRows, _MaxCols> type;
34 // construct 3 matrix guaranteed to be distinct
57 // test swapping matrix with expression
71 // test assertion on mismatching size -- matrix case
  /external/eigen/test/
exceptions.cpp 90 typedef Eigen::Matrix<ScalarWithExceptions,Dynamic,1> VectorType;
91 typedef Eigen::Matrix<ScalarWithExceptions,Dynamic,Dynamic> MatrixType;
product_mmtr.cpp 24 typedef Matrix<Scalar,Dynamic,Dynamic,ColMajor> MatrixColMaj;
25 typedef Matrix<Scalar,Dynamic,Dynamic,RowMajor> MatrixRowMaj;
schur_complex.cpp 58 // Test matrix with NaN
69 CALL_SUBTEST_3(( schur<Matrix<std::complex<float>, 1, 1> >() ));
70 CALL_SUBTEST_4(( schur<Matrix<float, 3, 3, Eigen::RowMajor> >() ));
schur_real.cpp 77 // Test matrix with NaN
88 CALL_SUBTEST_3(( schur<Matrix<float, 1, 1> >() ));
89 CALL_SUBTEST_4(( schur<Matrix<double, 3, 3, Eigen::RowMajor> >() ));
sparse_solver.h 135 typedef Matrix<Scalar,Dynamic,Dynamic> DenseMatrix;
174 typedef Matrix<Scalar,Dynamic,Dynamic> DenseMatrix;
175 typedef Matrix<Scalar,Dynamic,1> DenseVector;
212 halfA.template selfadjointView<Solver::UpLo>() = it.matrix().template triangularView<Eigen::Lower>().twistedBy(pnull);
214 std::cout<< " ==== SOLVING WITH MATRIX " << it.matname() << " ==== \n";
215 check_sparse_solving_real_cases(solver, it.matrix(), it.rhs(), it.refX());
226 typedef Matrix<Scalar,Dynamic,Dynamic> DenseMatrix;
244 typedef Matrix<Scalar,Dynamic,Dynamic> DenseMatrix;
261 typedef Matrix<Scalar,Dynamic,Dynamic> DenseMatrix;
262 typedef Matrix<Scalar,Dynamic,1> DenseVector
    [all...]
swap.cpp 20 struct other_matrix_type<Matrix<_Scalar, _Rows, _Cols, _Options, _MaxRows, _MaxCols> >
22 typedef Matrix<_Scalar, _Rows, _Cols, _Options^RowMajor, _MaxRows, _MaxCols> type;
34 // construct 3 matrix guaranteed to be distinct
57 // test swapping matrix with expression
71 // test assertion on mismatching size -- matrix case
corners.cpp 13 VERIFY_IS_EQUAL(matrix.A, matrix.B); \
25 MatrixType matrix = MatrixType::Random(rows,cols); local
48 MatrixType matrix = MatrixType::Random(); local
60 VERIFY_IS_EQUAL((matrix.template topLeftCorner<r,c>()), (matrix.template block<r,c>(0,0)));
61 VERIFY_IS_EQUAL((matrix.template topRightCorner<r,c>()), (matrix.template block<r,c>(0,cols-c)));
62 VERIFY_IS_EQUAL((matrix.template bottomLeftCorner<r,c>()), (matrix.template block<r,c>(rows-r,0)))
    [all...]
  /external/eigen/unsupported/Eigen/src/IterativeSolvers/
IncompleteLU.h 19 typedef Matrix<Scalar,Dynamic,1> Vector;
24 typedef Matrix<Scalar,Dynamic,Dynamic> MatrixType;
85 && "IncompleteLU::solve(): invalid number of rows of the right hand side matrix b");
  /external/eigen/unsupported/Eigen/src/NonLinearOptimization/
covar.h 7 Matrix< Scalar, Dynamic, Dynamic > &r,
21 Matrix< Scalar, Dynamic, 1 > wa(n);
45 /* form the full lower triangle of the covariance matrix */
62 /* symmetrize the covariance matrix in r. */
  /external/eigen/unsupported/test/
alignedvector3.cpp 18 typedef Matrix<Scalar,3,1> RefType;
19 typedef Matrix<Scalar,3,3> Mat33;
  /external/llvm/include/llvm/CodeGen/
RegAllocPBQP.h 134 void addInterferenceCosts(PBQP::Matrix &costMat,
155 void addVirtRegCoalesce(PBQP::Matrix &costMat,
  /frameworks/base/core/java/android/view/
GLES20RenderLayer.java 20 import android.graphics.Matrix;
121 void setTransform(Matrix matrix) {
  /external/eigen/bench/spbench/
spbenchsolver.h 119 out << "<TR><TH>Matrix <TH> N <TH> NNZ <TH> ";
126 Stats call_solver(Solver &solver, const typename Solver::MatrixType& A, const Matrix<Scalar, Dynamic, 1>& b, const Matrix<Scalar, Dynamic, 1>& refX)
129 Matrix<Scalar, Dynamic, 1> x;
163 Matrix<Scalar, Dynamic, 1> temp;
180 Stats call_directsolver(Solver& solver, const typename Solver::MatrixType& A, const Matrix<Scalar, Dynamic, 1>& b, const Matrix<Scalar, Dynamic, 1>& refX)
188 Stats call_itersolver(Solver &solver, const typename Solver::MatrixType& A, const Matrix<Scalar, Dynamic, 1>& b, const Matrix<Scalar, Dynamic, 1>& refX)
241 /* Print the results from all solvers corresponding to a particular matrix
    [all...]
  /external/ceres-solver/internal/ceres/
compressed_row_sparse_matrix.h 51 // Build a matrix with the same content as the TripletSparseMatrix
60 // creates a "blank" matrix with the appropriate amount of memory
66 // size of the matrix to begin with and wants to update the layout
74 // Build a square sparse diagonal matrix with num_rows rows and
87 virtual void ToDenseMatrix(Matrix* dense_matrix) const;
99 // Append the contents of m to the bottom of this matrix. m must
100 // have the same number of columns as this matrix.
103 void ToCRSMatrix(CRSMatrix* matrix) const;
105 // Low level access methods that expose the structure of the matrix.
138 // If the matrix has an underlying block structure, then it can als
    [all...]
triplet_sparse_matrix.h 62 virtual void ToDenseMatrix(Matrix* dense_matrix) const;
78 // Append the matrix B at the bottom of this matrix. B should have
82 // Append the matrix B at the right of this matrix. B should have
86 // Resize the matrix. Entries which fall outside the new matrix
96 // Returns true if the entries of the matrix obey the row, column,
102 // Build a sparse diagonal matrix of size num_rows x num_rows from
104 // sparse matrix
    [all...]
  /external/chromium_org/third_party/WebKit/Source/platform/transforms/
TransformOperation.h 45 Matrix,
  /external/chromium_org/third_party/skia/src/animator/
SkDrawMatrix.h 21 DECLARE_DRAW_MEMBER_INFO(Matrix);
65 SkTDScalarArray matrix; member in class:SkDrawMatrix
SkDrawShader.cpp 19 SK_MEMBER(matrix, Matrix),
27 SkDrawShader::SkDrawShader() : matrix(NULL),
40 if (matrix)
41 shader->setLocalMatrix(matrix->getMatrix());
  /external/eigen/Eigen/src/Core/products/
TriangularSolverVector.h 38 typedef Map<const Matrix<LhsScalar,Dynamic,Dynamic,RowMajor>, 0, OuterStride<> > LhsMap;
74 rhs[i] -= (cjLhs.row(i).segment(s,k).transpose().cwiseProduct(Map<const Matrix<RhsScalar,Dynamic,1> >(rhs+s,k))).sum();
92 typedef Map<const Matrix<LhsScalar,Dynamic,Dynamic,ColMajor>, 0, OuterStride<> > LhsMap;
117 Map<Matrix<RhsScalar,Dynamic,1> >(rhs+s,r) -= rhs[i] * cjLhs.col(i).segment(s,r);
  /external/eigen/Eigen/src/misc/
Kernel.h 24 typedef Matrix<
26 MatrixType::ColsAtCompileTime, // the number of rows in the "kernel matrix"
27 // is the number of cols of the original matrix
28 // so that the product "matrix * kernel = zero" makes sense
33 // whose dimension is the number of columns of the original matrix
  /external/eigen/bench/
benchmarkSlice.cpp 20 typedef Matrix<SCALAR, Eigen::Dynamic, Eigen::Dynamic> Mat;
sparse_trisolver.cpp 64 typedef Matrix<Scalar,Dynamic,1> DenseVector;
82 Matrix<Scalar,Dynamic,Dynamic,Dynamic,Dynamic,RowMajorBit> m2(rows,cols);
143 Map<Matrix<Scalar,Dynamic,1> >(&gmmX[0], cols) = x;
144 Map<Matrix<Scalar,Dynamic,1> >(&gmmB[0], cols) = b;
149 // std::cerr << Map<Matrix<Scalar,Dynamic,1> >(&gmmX[0], cols).transpose() << "\n";
155 // std::cerr << Map<Matrix<Scalar,Dynamic,1> >(&gmmX[0], cols).transpose() << "\n";
spmv.cpp 177 Map<Matrix<Scalar,Dynamic,1> >(&uv[0], cols) = dv;
178 Map<Matrix<Scalar,Dynamic,1> >(&ures[0], rows) = res;
195 Map<Matrix<Scalar,Dynamic,1> >(&gv[0], cols) = dv;
196 Map<Matrix<Scalar,Dynamic,1> >(&gres[0], rows) = res;

Completed in 423 milliseconds

<<11121314151617181920>>