HomeSort by relevance Sort by last modified time
    Searched defs:Rows (Results 1 - 25 of 30) sorted by null

1 2

  /external/dng_sdk/source/
dng_matrix.h 48 dng_matrix (uint32 rows,
61 uint32 Rows () const
  /external/eigen/test/
diagonalmatrices.cpp 16 enum { Rows = MatrixType::RowsAtCompileTime, Cols = MatrixType::ColsAtCompileTime };
17 typedef Matrix<Scalar, Rows, 1> VectorType;
19 typedef Matrix<Scalar, Rows, Rows> SquareMatrixType;
20 typedef DiagonalMatrix<Scalar, Rows> LeftDiagonalMatrix;
22 typedef Matrix<Scalar, Rows==Dynamic?Dynamic:2*Rows, Cols==Dynamic?Dynamic:2*Cols> BigMatrix;
23 Index rows = m.rows(); local
26 MatrixType m1 = MatrixType::Random(rows, cols)
    [all...]
permutationmatrices.cpp 17 enum { Rows = MatrixType::RowsAtCompileTime, Cols = MatrixType::ColsAtCompileTime,
19 typedef PermutationMatrix<Rows> LeftPermutationType;
20 typedef Matrix<int, Rows, 1> LeftPermutationVectorType;
26 Index rows = m.rows(); local
29 MatrixType m_original = MatrixType::Random(rows,cols);
31 randomPermutationVector(lv, rows);
38 for (int i=0; i<rows; i++)
42 Matrix<Scalar,Rows,Rows> lm(lp)
    [all...]
qr.cpp 17 Index rows = m.rows(); local
23 MatrixType a = MatrixType::Random(rows,cols);
35 enum { Rows = MatrixType::RowsAtCompileTime, Cols = MatrixType::ColsAtCompileTime };
37 Matrix<Scalar,Rows,Cols> m1 = Matrix<Scalar,Rows,Cols>::Random();
38 HouseholderQR<Matrix<Scalar,Rows,Cols> > qr(m1);
40 Matrix<Scalar,Rows,Cols> r = qr.matrixQR();
42 for(int i = 0; i < Rows; i++) for(int j = 0; j < Cols; j++) if(i>j) r(i,j) = Scalar(0);
47 Matrix<Scalar,Rows,Cols2> m3 = m1*m2
    [all...]
qr_colpivoting.cpp 18 Index rows = internal::random<Index>(2,EIGEN_TEST_MAX_SIZE), cols = internal::random<Index>(2,EIGEN_TEST_MAX_SIZE), cols2 = internal::random<Index>(2,EIGEN_TEST_MAX_SIZE); local
19 Index rank = internal::random<Index>(1, (std::min)(rows, cols)-1);
24 createRandomPIMatrixOfRank(rank,rows,cols,m1);
48 enum { Rows = MatrixType::RowsAtCompileTime, Cols = MatrixType::ColsAtCompileTime };
50 int rank = internal::random<int>(1, (std::min)(int(Rows), int(Cols))-1);
51 Matrix<Scalar,Rows,Cols> m1;
52 createRandomPIMatrixOfRank(rank,Rows,Cols,m1);
53 ColPivHouseholderQR<Matrix<Scalar,Rows,Cols> > qr(m1);
56 VERIFY(qr.isInjective() == (rank == Rows));
60 Matrix<Scalar,Rows,Cols> r = qr.matrixQR().template triangularView<Upper>()
    [all...]
triangular.cpp 22 typename MatrixType::Index rows = m.rows(); local
25 MatrixType m1 = MatrixType::Random(rows, cols),
26 m2 = MatrixType::Random(rows, cols),
27 m3(rows, cols),
28 m4(rows, cols),
29 r1(rows, cols),
30 r2(rows, cols);
31 VectorType v2 = VectorType::Random(rows);
36 if (rows*cols>1
127 Index rows = m.rows(); local
    [all...]
main.h 350 void createRandomPIMatrixOfRank(typename MatrixType::Index desired_rank, typename MatrixType::Index rows, typename MatrixType::Index cols, MatrixType& m);
352 void createRandomPIMatrixOfRank(typename MatrixType::Index desired_rank, typename MatrixType::Index rows, typename MatrixType::Index cols, MatrixType& m)
356 enum { Rows = MatrixType::RowsAtCompileTime, Cols = MatrixType::ColsAtCompileTime };
359 typedef Matrix<Scalar, Rows, Rows> MatrixAType;
364 m.setZero(rows,cols);
371 m = VectorType::Random(rows).normalized() * VectorType::Random(cols).normalized().transpose();
375 MatrixAType a = MatrixAType::Random(rows,rows);
376 MatrixType d = MatrixType::Identity(rows,cols)
    [all...]
  /external/llvm/include/llvm/DebugInfo/DWARF/
DWARFUnitIndex.h 67 std::unique_ptr<Entry[]> Rows;
DWARFDebugLine.h 150 // and is described by line table rows [FirstRowIndex, LastRowIndex).
178 Rows.push_back(R);
206 /// Parse prologue and all rows.
215 RowVector Rows;
  /external/webrtc/webrtc/modules/desktop_capture/
desktop_region.h 25 // Internally each region is stored as a set of rows where each row contains one
59 // Type used to store list of rows in the region. The bottom position of row
60 // is used as the key so that rows are always ordered by their position. The
62 typedef std::map<int, Row*> Rows;
81 // |row_span_| matches spans on consecutive rows then they are also merged
85 Rows::const_iterator row_;
86 Rows::const_iterator previous_row_;
157 // the region). If the rows were merged |row| remains a valid iterator to the
159 void MergeWithPrecedingRow(Rows::iterator row);
161 Rows rows_
    [all...]
  /external/libgdx/extensions/gdx-bullet/jni/src/bullet/BulletDynamics/MLCPSolvers/
btLemkeAlgorithm.cpp 226 int dim = A.rows();
227 btAlignedObjectArray<btVectorXu> Rows;
233 Rows.push_back(vec);
236 Rows[row][0] = A(row, 2 * dim + 1) / a;
237 Rows[row][1] = A(row, 2 * dim) / a;
239 Rows[row][j] = A(row, j - 1) / a;
243 // cout << "Rows(" << row << ") = " << Rows[row] << endl;
249 for (int i = 0; i < Rows.size(); i++)
251 if (Rows[i].nrm2() > 0.)
    [all...]
  /external/opencv3/modules/cudaarithm/perf/
perf_reductions.cpp 341 enum {Rows = 0, Cols = 1};
342 CV_ENUM(ReduceDim, Rows, Cols)
  /external/eigen/unsupported/Eigen/src/KroneckerProduct/
KroneckerTensorProduct.h 46 inline Index rows() const { return m_A.rows() * m_B.rows(); } function in class:Eigen::KroneckerProduct
51 return m_A.coeff(row / m_B.rows(), col / m_B.cols()) *
52 m_B.coeff(row % m_B.rows(), col % m_B.cols());
94 inline Index rows() const { return m_A.rows() * m_B.rows(); } function in class:Eigen::KroneckerProductSparse
116 const Index Br = m_B.rows(),
118 for (Index i=0; i < m_A.rows(); ++i
    [all...]
  /prebuilts/gcc/linux-x86/host/x86_64-w64-mingw32-4.8/x86_64-w64-mingw32/include/
d3dx9effect.h 48 UINT Rows;
d3d10shader.h 151 UINT Rows;
d3d11shader.h 95 UINT Rows;
d3d10effect.h 69 UINT Rows;
    [all...]
  /external/pdfium/core/src/fpdfapi/fpdf_parser/
fpdf_parser_decode.cpp 232 int Rows = 0;
239 Rows = pParams->GetInteger("Rows");
240 if (Rows > USHRT_MAX) {
241 Rows = 0;
243 if (Columns <= 0 || Rows < 0 || Columns > USHRT_MAX || Rows > USHRT_MAX) {
249 Columns, Rows);
  /hardware/intel/img/psb_video/src/mrst/
lnc_hostcode.c     [all...]
  /external/eigen/Eigen/src/Core/
GeneralProduct.h 45 template<int Rows, int Cols, int Depth> struct product_type_selector;
63 Rows = _Lhs::RowsAtCompileTime,
77 rows_select = product_size_category<Rows,MaxRows>::value,
90 EIGEN_DEBUG_VAR(Rows);
244 const Index rows = dest.rows(); local
245 for (Index i=0; i<rows; ++i)
347 eigen_assert(m_lhs.rows() == dst.rows() && m_rhs.cols() == dst.cols());
463 actualLhs.rows(), actualLhs.cols()
550 const Index rows = prod.rows(); local
    [all...]
  /external/eigen/Eigen/src/Geometry/
Transform.h 187 Rows = int(Mode)==(AffineCompact) ? Dim : HDim
193 typedef typename internal::make_proper_matrix_type<Scalar,Rows,HDim,Options>::type MatrixType;
    [all...]
  /external/eigen/unsupported/Eigen/src/MatrixFunctions/
MatrixFunction.h 74 static const int Rows = Traits::RowsAtCompileTime;
81 typedef Matrix<ComplexScalar, Rows, Cols, Options, MaxRows, MaxCols> ComplexMatrix;
239 const Index rows = m_T.rows(); local
242 for (Index i=0; i<rows; ++i) {
254 for (Index j=i+1; j<rows; ++j) {
289 const Index rows = m_T.rows(); local
294 m_eivalToCluster.resize(rows);
297 for (Index i = 0; i < diag.rows(); ++i)
528 Index rows() const { return m_A.rows(); } function in class:Eigen::MatrixFunctionReturnValue
    [all...]
  /external/llvm/utils/TableGen/
RegisterInfoEmitter.cpp 646 SmallVector<SmallVector<CodeGenSubRegIndex*, 4>, 4> Rows;
652 for (unsigned r = 0, re = Rows.size(); r != re; ++r) {
653 if (combine(&Idx, Rows[r])) {
659 Found = Rows.size();
660 Rows.resize(Found + 1);
661 Rows.back().resize(SubRegIndicesSize);
662 combine(&Idx, Rows.back());
667 // Output the row map if there is multiple rows.
668 if (Rows.size() > 1) {
669 OS << " static const " << getMinimalTypeForRange(Rows.size()) << " RowMap[
    [all...]
  /external/deqp/modules/gles2/functional/
es2fShaderMatrixTests.cpp 392 template <typename T, int Rows, int Cols>
393 tcu::Matrix<T, Rows, Cols> matrixCompMult (const tcu::Matrix<T, Rows, Cols>& a, const tcu::Matrix<T, Rows, Cols>& b)
395 tcu::Matrix<T, Rows, Cols> retVal;
397 for (int r = 0; r < Rows; ++r)
406 template <typename T, int Rows, int Cols>
407 tcu::Matrix<T, Rows, Cols> negate (const tcu::Matrix<T, Rows, Cols>& mat)
409 tcu::Matrix<T, Rows, Cols> retVal
    [all...]
  /hardware/intel/img/psb_video/src/
pnw_hostcode.c     [all...]

Completed in 1272 milliseconds

1 2