/prebuilts/ndk/r11/platforms/android-24/arch-mips64/usr/include/linux/ |
virtio_console.h | 31 __u16 cols; member in struct:virtio_console_config
|
/prebuilts/ndk/r11/platforms/android-24/arch-x86/usr/include/linux/ |
virtio_console.h | 31 __u16 cols; member in struct:virtio_console_config
|
/prebuilts/ndk/r11/platforms/android-24/arch-x86_64/usr/include/linux/ |
virtio_console.h | 31 __u16 cols; member in struct:virtio_console_config
|
/prebuilts/tools/common/spantable/ |
spantable.jar | |
/external/eigen/test/ |
conservative_resize.cpp | 41 const Index cols = internal::random<Index>(1,50); local 43 m.conservativeResize(rows,cols); 44 VERIFY_IS_APPROX(m, n.block(0,0,rows,cols)); 51 const Index cols = internal::random<Index>(50,75); local 53 m.conservativeResizeLike(MatrixType::Zero(rows,cols)); 54 VERIFY_IS_APPROX(m.block(0,0,n.rows(),n.cols()), n); 55 VERIFY( rows<=50 || m.block(50,0,rows-50,cols).sum() == Scalar(0) ); 56 VERIFY( cols<=50 || m.block(0,50,rows,cols-50).sum() == Scalar(0) );
|
permutationmatrices.cpp | 19 enum { Rows = MatrixType::RowsAtCompileTime, Cols = MatrixType::ColsAtCompileTime, 24 typedef PermutationMatrix<Cols> RightPermutationType; 25 typedef Matrix<int, Cols, 1> RightPermutationVectorType; 29 Index cols = m.cols(); local 31 MatrixType m_original = MatrixType::Random(rows,cols); 36 randomPermutationVector(rv, cols); 38 MatrixType m_permuted = MatrixType::Random(rows,cols); 43 for (int j=0; j<cols; j++) 47 Matrix<Scalar,Cols,Cols> rm(rp) [all...] |
product_symm.cpp | 22 Index cols = size; local 24 MatrixType m1 = MatrixType::Random(rows, cols), 25 m2 = MatrixType::Random(rows, cols), m3; 29 Rhs1 rhs1 = Rhs1::Random(cols, othersize), rhs12(cols, othersize), rhs13(cols, othersize); 31 Rhs3 rhs3 = Rhs3::Random(cols, othersize), rhs32(cols, othersize), rhs33(cols, othersize);
|
product_trmm.cpp | 22 int cols=get_random_size<Scalar>(), 32 TriMatrix mat(rows,cols), tri(rows,cols), triTr(cols,rows); 34 OnTheRight ge_right(cols,otherCols); 72 void trmv(int rows=get_random_size<Scalar>(), int cols=get_random_size<Scalar>()) 74 trmm<Scalar,Mode,TriOrder,ColMajor,ColMajor,1>(rows,cols,1); 78 void trmm(int rows=get_random_size<Scalar>(), int cols=get_random_size<Scalar>(), int otherCols = get_random_size<Scalar>()) 80 trmm<Scalar,Mode,TriOrder,OtherOrder,ResOrder,Dynamic>(rows,cols,otherCols);
|
/external/libhevc/decoder/x86/ |
ihevcd_fmt_conv_ssse3_intr.c | 63 WORD32 num_rows, num_cols, src_strd, dst_strd, cols, rows; local 66 cols = 0; 128 cols = num_cols >> 4; 143 for(j = 0; j < cols; j++) 219 for(j = 0; j < cols; j++) 250 pu1_u_dst += (cols << 4); 251 pu1_v_dst += (cols << 4); 252 pu1_u_src += 2 * (cols << 4); 253 pu1_v_src += 2 * (cols << 4);
|
/external/eigen/Eigen/src/Core/products/ |
TriangularMatrixMatrix.h | 60 Index rows, Index cols, Index depth, 74 ::run(cols, rows, depth, rhs, rhsStride, lhs, lhsStride, res, resStride, alpha, blocking); 118 Index cols = _cols; local 135 std::size_t sizeB = kc*cols; 165 pack_rhs(blockB, rhs.getSubMapper(actual_k2,0), actual_kc, cols); 196 actualPanelWidth, actualPanelWidth, cols, alpha, 207 lengthTarget, actualPanelWidth, cols, alpha, 223 actual_kc, cols, alpha, -1, -1, 0, 0); 269 Index cols = IsLower ? diagSize : _cols; local 282 std::size_t sizeB = kc*cols+EIGEN_MAX_ALIGN_BYTES/sizeof(Scalar) [all...] |
/external/eigen/Eigen/src/Core/ |
BandMatrix.h | 51 using Base::cols; 85 { return Block<CoefficientsType,1,SizeAtCompileTime>(coeffs(),supers(),0,1,(std::min)(rows(),cols())); } 89 { return Block<const CoefficientsType,1,SizeAtCompileTime>(coeffs(),supers(),0,1,(std::min)(rows(),cols())); } 136 dst.resize(rows(),cols()); 147 DenseMatrixType res(rows(),cols()); 155 { return i<0 ? (std::min)(cols(),rows()+i) : (std::min)(rows(),cols()-i); } 198 template<typename _Scalar, int Rows, int Cols, int Supers, int Subs, int Options> 199 class BandMatrix : public BandMatrixBase<BandMatrix<_Scalar,Rows,Cols,Supers,Subs,Options> > 207 explicit inline BandMatrix(Index rows=Rows, Index cols=Cols, Index supers=Supers, Index subs=Subs 217 inline Index cols() const { return m_coeffs.cols(); } function in class:Eigen::internal::BandMatrix 281 inline Index cols() const { return m_coeffs.cols(); } function in class:Eigen::internal::BandMatrixWrapper [all...] |
CwiseTernaryOp.h | 125 eigen_assert(a1.rows() == a2.rows() && a1.cols() == a2.cols() && 126 a1.rows() == a3.rows() && a1.cols() == a3.cols()); 147 EIGEN_STRONG_INLINE Index cols() const { function in class:Eigen::CwiseTernaryOp 154 return m_arg3.cols(); 159 return m_arg2.cols(); 161 return m_arg1.cols();
|
/external/gemmlowp/test/ |
benchmark.cc | 63 int rows, depth, cols; member in struct:gemmlowp::gemm_t 64 gemm_t() : rows(0), depth(0), cols(0) {} 65 gemm_t(int r, int d, int c) : rows(r), depth(d), cols(c) {} 71 (a.depth < b.depth || (a.depth <= b.depth && (a.cols < b.cols)))); 84 int cols = gemm.cols; local 86 sizeof(Scalar) * (rows * depth + depth * cols + rows * cols); 100 rhs[k].Resize(gemms[j].depth, gemms[j].cols); [all...] |
test.cc | 139 const int cols = rhs.cols(); local 140 if (rows < cols) { 141 // SingleThreadGemm is never called with rows < cols. 146 const OffsetRowDup rhs_offset_vector(rhs_offset, cols); 180 const int cols = rhs.cols(); local 181 if (rows < cols) { 182 // SingleThreadGemm is never called with rows < cols. 187 const OffsetRowDup rhs_offset_vector(rhs_offset, cols); 407 const int cols = rhs.cols(); local [all...] |
/external/opencv/cvaux/src/ |
cvbgfg_codebook.cpp | 105 roi.width = image->cols; 109 CV_ASSERT( (unsigned)roi.x < (unsigned)image->cols && 112 roi.x + roi.width <= image->cols && 115 if( image->cols != model->size.width || image->rows != model->size.height ) 120 int bufSz = image->cols*image->rows*sizeof(model->cbmap[0]); 123 model->size = cvSize(image->cols, image->rows); 142 CvBGCodeBookElem** cb = model->cbmap + image->cols*(y + roi.y) + roi.x; 241 image->cols == model->size.width && image->rows == model->size.height && 246 roi.width = image->cols; 250 CV_ASSERT( (unsigned)roi.x < (unsigned)image->cols & [all...] |
/external/eigen/Eigen/src/SPQRSupport/ |
SuiteSparseQRSupport.h | 117 for (int j = 0; j < mat.cols(); j++) max2Norm = numext::maxi(max2Norm, mat.col(j).norm()); 120 pivotThreshold = 20 * (mat.rows() + mat.cols()) * max2Norm * NumTraits<RealScalar>::epsilon(); 125 Index col = matrix.cols(); 147 inline Index cols() const { return m_cR->ncol; } function in class:Eigen::SPQR 153 eigen_assert(b.cols()==1 && "This method is for vectors only"); 162 y.resize((std::max)(cols(),Index(y.rows())),y.cols()); 169 for(Index i = rk; i < cols(); ++i) dest.row(m_E[i]).setZero(); 172 // dest = colsPermutation() * y.topRows(cols()); 201 * It should be equal to matrixQR().cols if the matrix is full-ran 261 inline Index cols() const { return m_other.cols(); } function in struct:Eigen::SPQR_QProduct [all...] |
/external/eigen/unsupported/Eigen/src/KroneckerProduct/ |
KroneckerTensorProduct.h | 42 inline Index cols() const { return m_A.cols() * m_B.cols(); } function in class:Eigen::KroneckerProductBase 50 return m_A.coeff(row / m_B.rows(), col / m_B.cols()) * 51 m_B.coeff(row % m_B.rows(), col % m_B.cols()); 139 Bc = m_B.cols(); 141 for (Index j=0; j < m_A.cols(); ++j) 149 Index Br = m_B.rows(), Bc = m_B.cols(); 150 dst.resize(this->rows(), this->cols()); 168 VectorXi nnzA = VectorXi::Zero(Dest::IsRowMajor ? m_A.rows() : m_A.cols()); [all...] |
/external/eigen/unsupported/Eigen/src/Skyline/ |
SkylineProduct.h | 78 eigen_assert(lhs.cols() == rhs.rows()); 101 EIGEN_STRONG_INLINE Index cols() const { function in class:Eigen::internal::SkylineProduct 102 return m_rhs.cols(); 138 for (Index col = 0; col < rhs.cols(); col++) { 147 for (Index col = 0; col < rhs.cols(); col++) { 164 for (Index lhscol = 0; lhscol < lhs.cols(); lhscol++) { 167 for (Index rhscol = 0; rhscol < rhs.cols(); rhscol++) { 201 for (Index col = 0; col < rhs.cols(); col++) { 211 for (Index col = 0; col < rhs.cols(); col++) { 229 for (Index lhscol = 0; lhscol < lhs.cols(); lhscol++) [all...] |
/external/opencv/ml/src/ |
ml_inner_functions.cpp | 160 int dim = sample->cols; 220 int dim = sample->cols; 277 int dim = data ? data->cols : 0; 345 CV_ASSERT (center->cols == desired_matrix->cols); 347 dim = desired_matrix->cols; 377 int rows, cols; local 385 cols = matrix->cols; 405 for( j = i+1; j < cols; j++, src += step [all...] |
/external/libvterm/src/ |
screen.c | 56 int cols; member in struct:VTermScreen 75 if(col < 0 || col >= screen->cols) 77 return screen->buffer + (screen->cols * row) + col; 88 if(buffer && row < screen->rows && col < screen->cols) 89 *new_cell = buffer[row * screen->cols + col]; 166 .end_col = screen->cols, 213 dest.end_col == screen->cols && // full width 217 for(pos.col = 0; pos.col < screen->cols; pos.col++) 220 (screen->callbacks->sb_pushline)(screen->cols, screen->sb_buffer, screen->cbdata); 224 int cols = src.end_col - src.start_col local 631 int rows, cols; local 829 int rows, cols; local [all...] |
/external/apache-commons-math/src/main/java/org/apache/commons/math/optimization/general/ |
LevenbergMarquardtOptimizer.java | 247 solvedCols = Math.min(rows, cols); 248 diagR = new double[cols]; 249 jacNorm = new double[cols]; 250 beta = new double[cols]; 251 permutation = new int[cols]; 252 lmDir = new double[cols]; 257 double[] diag = new double[cols]; 258 double[] oldX = new double[cols]; 262 double[] work1 = new double[cols]; 263 double[] work2 = new double[cols]; [all...] |
/external/eigen/Eigen/src/LU/ |
PartialPivLU_LAPACKE.h | 47 static lapack_int blocked_lu(Index rows, Index cols, EIGTYPE* lu_data, Index luStride, lapack_int* row_transpositions, lapack_int& nb_transpositions, lapack_int maxBlockSize=256) \ 59 n = convert_index<lapack_int>(cols); \
|
/external/eigen/Eigen/src/SparseCore/ |
MappedSparseMatrix.h | 42 inline MappedSparseMatrix(Index rows, Index cols, Index nnz, StorageIndex* outerIndexPtr, StorageIndex* innerIndexPtr, Scalar* valuePtr, StorageIndex* innerNonZeroPtr = 0) 43 : Base(rows, cols, nnz, outerIndexPtr, innerIndexPtr, valuePtr, innerNonZeroPtr)
|
/external/eigen/Eigen/src/misc/ |
Image.h | 49 inline Index cols() const { return m_cols; } function in struct:Eigen::internal::image_retval_base 76 using Base::cols; \
|
/external/webrtc/webrtc/tools/loopback_test/ |
stat_tracker.js | 82 function allColumns(cols) { 84 for (var i = 1; i < cols; ++i) a.push(i);
|