/external/eigen/Eigen/src/SparseLU/ |
D | SparseLU_kernel_bmod.h | 34 …static EIGEN_DONT_INLINE void run(const int segsize, BlockScalarVector& dense, ScalarVector& tempv… 40 …nel_bmod<SegSizeAtCompileTime>::run(const int segsize, BlockScalarVector& dense, ScalarVector& tem… in run() argument 53 tempv(i) = dense(irow); in run() 81 dense(irow) = tempv(i); in run() 88 dense(irow) -= l(i); in run() 95 …static EIGEN_DONT_INLINE void run(const int /*segsize*/, BlockScalarVector& dense, ScalarVector& /… 101 EIGEN_DONT_INLINE void LU_kernel_bmod<1>::run(const int /*segsize*/, BlockScalarVector& dense, Scal… 105 Scalar f = dense(lsub(lptr + no_zeros)); 116 Scalar d0 = dense.coeff(i0); 117 Scalar d1 = dense.coeff(i1); [all …]
|
D | SparseLUImpl.h | 40 Index snode_bmod (const Index jcol, const Index fsupc, ScalarVector& dense, GlobalLU_t& glu); 47 …ndex jcol, MatrixType& A, IndexVector& perm_r, Index& nseg, ScalarVector& dense, IndexVector& pane… 49 …Index m, const Index w, const Index jcol, const Index nseg, ScalarVector& dense, ScalarVector& tem… 51 …Index column_bmod(const Index jcol, const Index nseg, BlockScalarVector dense, ScalarVector& tempv… 52 …& segrep, BlockIndexVector repfnz ,IndexVector& perm_r, BlockScalarVector dense, GlobalLU_t& glu);
|
D | SparseLU_column_bmod.h | 53 …Index>::column_bmod(const Index jcol, const Index nseg, BlockScalarVector dense, ScalarVector& tem… in column_bmod() argument 105 …LU_kernel_bmod<1>::run(segsize, dense, tempv, glu.lusup, luptr, lda, nrow, glu.lsub, lptr, no_zero… in column_bmod() 107 …LU_kernel_bmod<Dynamic>::run(segsize, dense, tempv, glu.lusup, luptr, lda, nrow, glu.lsub, lptr, n… in column_bmod() 130 glu.lusup(nextlu) = dense(irow); in column_bmod() 131 dense(irow) = Scalar(0.0); in column_bmod()
|
D | SparseLU_copy_to_ucol.h | 50 …or& segrep, BlockIndexVector repfnz ,IndexVector& perm_r, BlockScalarVector dense, GlobalLU_t& glu) in copy_to_ucol() argument 88 glu.ucol(nextu) = dense(irow); in copy_to_ucol() 89 dense(irow) = Scalar(0.0); in copy_to_ucol()
|
D | SparseLU_panel_bmod.h | 57 … const Index nseg, ScalarVector& dense, ScalarVector& tempv, in panel_bmod() argument 113 …VectorBlock<ScalarVector> dense_col(dense, nextl_col, m); // Scatter/gather entire matrix column f… in panel_bmod() 160 …VectorBlock<ScalarVector> dense_col(dense, nextl_col, m); // Scatter/gather entire matrix column f… in panel_bmod() 195 …VectorBlock<ScalarVector> dense_col(dense, nextl_col, m); // Scatter/gather entire matrix column f… in panel_bmod()
|
D | SparseLU_panel_dfs.h | 219 …ndex jcol, MatrixType& A, IndexVector& perm_r, Index& nseg, ScalarVector& dense, IndexVector& pane… in panel_dfs() argument 235 VectorBlock<ScalarVector> dense_col(dense,nextl_col, m); // Accumulate a column vector here in panel_dfs()
|
D | SparseLU.h | 562 ScalarVector dense; in factorize() local 563 dense.setZero(maxpanel); in factorize() 612 …Base::panel_dfs(m, panel_size, jcol, m_mat, m_perm_r.indices(), nseg1, dense, panel_lsub, segrep, … in factorize() 615 Base::panel_bmod(m, panel_size, jcol, nseg1, dense, tempv, segrep, repfnz, m_glu); in factorize() 635 VectorBlock<ScalarVector> dense_k(dense, k, m); in factorize()
|
/external/ceres-solver/internal/ceres/ |
D | dynamic_compressed_row_sparse_matrix_test.cc | 71 dense.resize(num_rows, num_cols); in InitialiseDenseReference() 72 dense.setZero(); in InitialiseDenseReference() 77 dense(r, c) = i + 1; in InitialiseDenseReference() 107 ASSERT_TRUE((dense.array() == dense_from_tsm.array()).all()); in InitialiseSparseMatrixReferences() 112 ASSERT_TRUE((dense.array() == dense_from_crsm.array()).all()); in InitialiseSparseMatrixReferences() 118 const double& v = dense(r, c); in InsertNonZeroEntriesFromDenseReference() 141 EXPECT_TRUE((dense.array() == dense_from_dcrsm.array()).all()); in ExpectEqualToDenseReference() 167 Matrix dense; member in ceres::internal::DynamicCompressedRowSparseMatrixTest 210 dense.block(1, 0, 2, num_cols).setZero(); in TEST_F()
|
D | block_random_access_diagonal_matrix_test.cc | 91 Matrix dense; in TEST() local 92 tsm->ToDenseMatrix(&dense); in TEST() 97 EXPECT_NEAR((dense.block(0, 0, 3, 3) - Matrix::Ones(3, 3)).norm(), in TEST() 102 EXPECT_NEAR((dense.block(3, 3, 4, 4) - 2 * 2 * Matrix::Ones(4, 4)).norm(), in TEST() 107 EXPECT_NEAR((dense.block(7, 7, 5, 5) - 3 * 3 * Matrix::Ones(5, 5)).norm(), in TEST() 112 EXPECT_NEAR(dense.norm(), sqrt(9.0 + 16. * 16. + 81.0 * 25.), kTolerance); in TEST()
|
D | block_random_access_sparse_matrix_test.cc | 95 Matrix dense; in TEST() local 96 tsm->ToDenseMatrix(&dense); in TEST() 101 EXPECT_NEAR((dense.block(0, 0, 3, 3) - Matrix::Ones(3, 3)).norm(), in TEST() 105 EXPECT_NEAR((dense.block(3, 3, 4, 4) - 2 * 2 * Matrix::Ones(4, 4)).norm(), in TEST() 109 EXPECT_NEAR((dense.block(3, 3 + 4, 4, 5) - 2 * 3 * Matrix::Ones(4, 5)).norm(), in TEST() 113 EXPECT_NEAR((dense.block(3 + 4, 0, 5, 3) - 3 * 1 * Matrix::Ones(5, 3)).norm(), in TEST() 118 EXPECT_NEAR(dense.norm(), sqrt(9. + 16. * 16. + 36. * 20. + 9. * 15.), in TEST()
|
D | compressed_row_sparse_matrix_test.cc | 274 Matrix dense; in TEST() local 275 matrix->ToDenseMatrix(&dense); in TEST() 276 EXPECT_EQ((dense.diagonal() - diagonal).norm(), 0.0); in TEST()
|
/external/eigen/doc/ |
D | ClassHierarchy.dox | 31 …- Matrix means plain dense matrix. If \c m is a \c %Matrix, then, for instance, \c m+m is no longe… 33 …- MatrixBase means dense matrix expression. This means that a \c %MatrixBase is something that can… 36 …- Array means plain dense array. If \c x is an \c %Array, then, for instance, \c x+x is no longer … 38 …- ArrayBase means dense array expression. This means that an \c %ArrayBase is something that can be 41 …- DenseBase means dense (matrix or array) expression. Both \c %ArrayBase and \c %MatrixBase inherit 42 …\c %DenseBase. \c %DenseBase is where all the methods go that apply to dense expressions regardles… 51 …- PlainObjectBase means dense (matrix or array) plain object, i.e. something that stores its own d… 58 - DenseCoeffsBase means something that has dense coefficient accessors. It is a base class for 60 …accessors is very different depending on whether a dense expression has direct memory access or no… 65 …- EigenBase means anything that can be evaluated into a plain dense matrix or array (even if that … [all …]
|
D | TutorialSparse.dox | 104 …ctorization via the SimplicialLDLT class which behaves like its LDLT counterpart for dense objects. 122 As for dense Matrix objects, constructors takes the size of the object. 233 …ial storage format, sparse matrices cannot offer the same level of flexibility than dense matrices. 234 In Eigen's sparse module we chose to expose only the subset of the dense matrix API which can be ef… 235 …m denotes a sparse matrix, \em sv a sparse vector, \em dm a dense matrix, and \em dv a dense vecto… 256 Some binary coefficient-wise operators can also mix sparse and dense expressions: 262 However, it is not yet possible to add a sparse and a dense matrix as in <tt>dm2 = sm1 + dm1</tt>. 277 - \b sparse-dense: 283 …- \b symmetric \b sparse-dense. The product of a sparse symmetric matrix with a dense matrix (or v… 312 …ith dense matrices, the triangularView() function can be used to address a triangular part of the … [all …]
|
D | FunctionsTakingEigenTypes.dox | 17 …dense matrix expressions (as opposed to array expressions, as opposed to sparse and special matrix… 18 …\li ArrayBase: The common base class for all dense array expressions (as opposed to matrix express… 19 …\li DenseBase: The common base class for all dense matrix expression, that is, the base class for … 20 …\li EigenBase: The base class unifying all types of objects that can be evaluated into dense matri… 23 …generic object present in %Eigen. It could be any matrix expressions, any dense or sparse matrix a… 33 Prints a sub-block of the dense expression. Accepts any dense matrix or array expression, but no sp…
|
D | SparseLinearSystems.dox | 28 <td>Square </td><td>Fill-in reducing, Leverage fast dense algebra</td> 34 …ions</td><td>SPD \n SPD \n Square</td><td>Fill-in reducing, Leverage fast dense algebra, Multithre… 37 …<td>Direct LLt factorization</td><td>SPD</td><td>Fill-in reducing, Leverage fast dense algebra</td> 40 …d>Direct LU factorization</td><td>Square</td><td>Fill-in reducing, Leverage fast dense algebra</td> 43 …d>Direct LU factorization</td><td>Square</td><td>Fill-in reducing, Leverage fast dense algebra</td> 47 <td> Any, rectangular</td><td>fill-in reducing, multithreaded, fast dense algebra</td>
|
D | UsingIntelMKL.dox | 158 In the examples, m1 and m2 are dense matrices and v1 and v2 are dense vectors.
|
D | TopicLinearAlgebraDecompositions.dox | 3 /** \eigenManualPage TopicLinearAlgebraDecompositions Catalogue of dense decompositions 5 This page presents a catalogue of the dense matrix decompositions offered by Eigen.
|
D | SparseQuickReference.dox | 103 …er. In the following, \b sm denotes a sparse matrix, \b dm a dense matrix and \b dv a dense vector.
|
/external/jetty/src/java/org/eclipse/jetty/util/log/ |
D | StdErrLog.java | 211 StringBuilder dense = new StringBuilder(); in condensePackageString() local 214 dense.append(parts[i].charAt(0)); in condensePackageString() 216 if (dense.length() > 0) in condensePackageString() 218 dense.append('.'); in condensePackageString() 220 dense.append(parts[parts.length - 1]); in condensePackageString() 221 return dense.toString(); in condensePackageString()
|
/external/opencv3/modules/cudaoptflow/src/ |
D | pyrlk.cpp | 65 …void dense(PtrStepSzb I, PtrStepSzf J, PtrStepSzf u, PtrStepSzf v, PtrStepSzf prevU, PtrStepSzf pr… 79 … void dense(const GpuMat& prevImg, const GpuMat& nextImg, GpuMat& u, GpuMat& v, Stream& stream); 207 …void PyrLKOpticalFlowBase::dense(const GpuMat& prevImg, const GpuMat& nextImg, GpuMat& u, GpuMat& … in dense() function in __anonecd9e1d70111::PyrLKOpticalFlowBase 253 pyrlk::dense(prevPyr_[level], nextPyr_[level], in dense() 332 dense(prevImg, nextImg, u, v, stream); in calc()
|
/external/ceres-solver/docs/source/ |
D | features.rst | 50 solvers - dense QR and dense Cholesky factorization (using 51 `Eigen`_ or `LAPACK`_) for dense problems, sparse Cholesky 53 problems custom Schur complement based dense, sparse, and
|
D | solving.rst | 406 dimensions in which a full, dense approximation to the inverse 451 residuals) with relatively dense Jacobians, ``DENSE_QR`` is the method 460 Ceres uses ``Eigen`` 's dense QR factorization routines. 468 cases, using a dense QR factorization is inefficient. Let :math:`H = 483 factorization -- sparse and dense. 485 ``DENSE_NORMAL_CHOLESKY`` as the name implies performs a dense 487 ``Eigen`` 's dense LDLT factorization routines. 580 :math:`S` as a dense matrix [TrefethenBau]_. This method has 594 up over those based on dense factorization. Ceres implements this 729 completely dense factor. [all …]
|
/external/eigen/Eigen/src/OrderingMethods/ |
D | Amd.h | 96 k2, k3, jlast, ln, dense, nzmax, mindeg = 0, nvi, nvj, nvk, mark, wnvi, in minimum_degree_ordering() local 101 dense = std::max<Index> (16, Index(10 * sqrt(double(n)))); /* find dense threshold */ in minimum_degree_ordering() 102 dense = std::min<Index> (n-2, dense); in minimum_degree_ordering() 163 else if(d > dense || !has_diag) /* node i is dense or has no structural diagonal element */ in minimum_degree_ordering()
|
/external/opencv3/doc/py_tutorials/py_video/py_lucas_kanade/ |
D | py_lucas_kanade.markdown | 169 using Shi-Tomasi algorithm). OpenCV provides another algorithm to find the dense optical flow. It 174 Below sample shows how to find the dense optical flow using above algorithm. We get a 2-channel 215 OpenCV comes with a more advanced sample on dense optical flow, please see
|
/external/opencv/cv/src/ |
D | cvhistogram.cpp | 1415 CvMatND dense; in cvCalcArrHist() local 1481 dense = *(CvMatND*)hist->bins; in cvCalcArrHist() 1482 dense.type = (dense.type & ~CV_MAT_TYPE_MASK) | CV_32SC1; in cvCalcArrHist() 1491 CV_CALL( cvConvert( (CvMatND*)hist->bins, &dense )); in cvCalcArrHist() 1529 CV_CALL( cvConvert( &dense, (CvMatND*)hist->bins )); in cvCalcArrHist()
|