HomeSort by relevance Sort by last modified time
    Searched refs:Cols (Results 1 - 25 of 37) sorted by null

1 2

  /external/llvm/include/llvm/CodeGen/PBQP/
Math.h 169 Matrix(unsigned Rows, unsigned Cols) :
170 Rows(Rows), Cols(Cols), Data(new PBQPNum[Rows * Cols]) {
175 Matrix(unsigned Rows, unsigned Cols, PBQPNum InitVal)
176 : Rows(Rows), Cols(Cols), Data(new PBQPNum[Rows * Cols]) {
177 std::fill(Data, Data + (Rows * Cols), InitVal);
182 : Rows(M.Rows), Cols(M.Cols), Data(new PBQPNum[Rows * Cols])
    [all...]
  /external/deqp/framework/common/
tcuMatrix.hpp 34 template <typename T, int Rows, int Cols>
43 SIZE = Cols,
45 COLS = Cols,
50 explicit Matrix (const T src[Rows*Cols]);
52 Matrix (const Matrix<T, Rows, Cols>& src);
55 Matrix<T, Rows, Cols>& operator= (const Matrix<T, Rows, Cols>& src);
56 Matrix<T, Rows, Cols>& operator*= (const Matrix<T, Rows, Cols>& src)
    [all...]
  /external/eigen/test/
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);
27 VERIFY(cols - qr.rank() == qr.dimensionOfKernel());
39 MatrixType m2 = MatrixType::Random(cols,cols2);
41 m2 = MatrixType::Random(cols,cols2);
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)
    [all...]
qr.cpp 18 Index cols = m.cols(); 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);
46 Matrix<Scalar,Cols,Cols2> m2 = Matrix<Scalar,Cols,Cols2>::Random(Cols,Cols2)
    [all...]
diagonalmatrices.cpp 16 enum { Rows = MatrixType::RowsAtCompileTime, Cols = MatrixType::ColsAtCompileTime };
18 typedef Matrix<Scalar, 1, Cols> RowVectorType;
21 typedef DiagonalMatrix<Scalar, Cols> RightDiagonalMatrix;
22 typedef Matrix<Scalar, Rows==Dynamic?Dynamic:2*Rows, Cols==Dynamic?Dynamic:2*Cols> BigMatrix;
24 Index cols = m.cols(); local
26 MatrixType m1 = MatrixType::Random(rows, cols),
27 m2 = MatrixType::Random(rows, cols);
30 RowVectorType rv1 = RowVectorType::Random(cols),
    [all...]
permutationmatrices.cpp 17 enum { Rows = MatrixType::RowsAtCompileTime, Cols = MatrixType::ColsAtCompileTime,
22 typedef PermutationMatrix<Cols> RightPermutationType;
23 typedef Matrix<int, Cols, 1> RightPermutationVectorType;
27 Index cols = m.cols(); local
29 MatrixType m_original = MatrixType::Random(rows,cols);
34 randomPermutationVector(rv, cols);
39 for (int j=0; j<cols; j++)
43 Matrix<Scalar,Cols,Cols> rm(rp)
    [all...]
product_trsolve.cpp 30 template<typename Scalar,int Size, int Cols> void trsolve(int size=Size,int cols=Cols)
38 rowmajor = Cols==1 ? ColMajor : RowMajor };
39 Matrix<Scalar,Size,Cols,colmajor> cmRhs(size,cols);
40 Matrix<Scalar,Size,Cols,rowmajor> rmRhs(size,cols);
41 Matrix<Scalar,Dynamic,Dynamic,colmajor> ref(size,cols);
71 int c = internal::random<int>(0,cols-1)
    [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 };
360 typedef Matrix<Scalar, Cols, Cols> MatrixBType;
364 m.setZero(rows,cols);
371 m = VectorType::Random(rows).normalized() * VectorType::Random(cols).normalized().transpose();
376 MatrixType d = MatrixType::Identity(rows,cols);
377 MatrixBType b = MatrixBType::Random(cols,cols);
    [all...]
  /external/dng_sdk/source/
dng_matrix.cpp 35 uint32 cols)
43 cols < 1 || cols > kMaxColorPlanes)
51 fCols = cols;
114 Cols () != m.Cols ())
122 for (uint32 k = 0; k < Cols (); k++)
148 if (Rows () != Cols ())
154 for (uint32 k = 0; k < Cols (); k++)
188 for (uint32 k = 0; k < Cols (); k++
    [all...]
dng_camera_profile.cpp 228 cameraOne.SetIdentity (m.Cols ());
297 return fColorMatrix1.Cols () == 3 &&
307 return fColorMatrix2.Cols () == 3 &&
421 if (fForwardMatrix1.Rows () == fColorMatrix1.Cols () &&
422 fForwardMatrix1.Cols () == fColorMatrix1.Rows ())
430 fReductionMatrix1.Cols () == colorChannels * 3)
444 if (fForwardMatrix2.Rows () == fColorMatrix2.Cols () &&
445 fForwardMatrix2.Cols () == fColorMatrix2.Rows ())
453 fReductionMatrix2.Cols () == colorChannels * 3)
568 cameraOne.SetIdentity (m.Cols ());
    [all...]
dng_color_space.h 117 return fMatrixToPCS.Cols () == 1;
dng_color_spec.cpp 130 negative.CameraCalibration1 ().Cols () == fChannels)
138 negative.CameraCalibration2 ().Cols () == fChannels)
dng_matrix.h 49 uint32 cols);
66 uint32 Cols () const
  /external/eigen/Eigen/src/Core/
NumTraits.h 124 template<typename Scalar, int Rows, int Cols, int Options, int MaxRows, int MaxCols>
125 struct NumTraits<Array<Scalar, Rows, Cols, Options, MaxRows, MaxCols> >
127 typedef Array<Scalar, Rows, Cols, Options, MaxRows, MaxCols> ArrayType;
129 typedef Array<RealScalar, Rows, Cols, Options, MaxRows, MaxCols> Real;
131 typedef Array<NonIntegerScalar, Rows, Cols, Options, MaxRows, MaxCols> NonInteger;
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); }
166 * \param Cols Number of columns, or \b Dynamic
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>
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...]
  /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;
398 for (int c = 0; c < Cols; ++c)
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...]
  /external/deqp/external/vulkancts/modules/vulkan/shaderexecutor/
vktShaderBuiltinPrecisionTests.cpp 461 template <typename T, int Rows, int Cols>
462 struct Traits<Matrix<T, Rows, Cols> > :
463 ContainerTraits<Matrix<T, Rows, Cols>, Matrix<typename Traits<T>::IVal, Rows, Cols> >
890 template <typename T, int Rows, int Cols>
891 class ExprP<Matrix<T, Rows, Cols> > : public ContainerExprPBase<Matrix<T, Rows, Cols> > {};
964 template<int Rows, int Cols>
965 ExprP<Vector<float, Rows> > operator* (const ExprP<Vector<float, Cols> >& left,
966 const ExprP<Matrix<float, Rows, Cols> >& right)
    [all...]
  /external/deqp/modules/glshared/
glsBuiltinPrecisionTests.cpp 482 template <typename T, int Rows, int Cols>
483 struct Traits<Matrix<T, Rows, Cols> > :
484 ContainerTraits<Matrix<T, Rows, Cols>, Matrix<typename Traits<T>::IVal, Rows, Cols> >
911 template <typename T, int Rows, int Cols>
912 class ExprP<Matrix<T, Rows, Cols> > : public ContainerExprPBase<Matrix<T, Rows, Cols> > {};
985 template<int Rows, int Cols>
986 ExprP<Vector<float, Rows> > operator* (const ExprP<Vector<float, Cols> >& left,
987 const ExprP<Matrix<float, Rows, Cols> >& right)
    [all...]
  /external/eigen/Eigen/src/SparseCore/
SparseUtil.h 95 template<typename T,int Rows,int Cols> struct sparse_eval;
101 template<typename T,int Cols> struct sparse_eval<T,1,Cols> {
115 template<typename T,int Rows,int Cols> struct sparse_eval {
  /external/deqp/external/vulkancts/modules/vulkan/shaderrender/
vktShaderRenderMatrixTests.cpp 618 template <typename T, int Rows, int Cols>
619 tcu::Matrix<T, Rows, Cols> matrixCompMult (const tcu::Matrix<T, Rows, Cols>& a, const tcu::Matrix<T, Rows, Cols>& b)
621 tcu::Matrix<T, Rows, Cols> retVal;
624 for (int c = 0; c < Cols; ++c)
632 template <typename T, int Rows, int Cols>
633 tcu::Matrix<T, Cols, Rows> transpose (const tcu::Matrix<T, Rows, Cols>& mat)
635 tcu::Matrix<T, Cols, Rows> retVal
    [all...]
  /external/deqp/modules/gles3/functional/
es3fShaderMatrixTests.cpp 623 template <typename T, int Rows, int Cols>
624 tcu::Matrix<T, Rows, Cols> matrixCompMult (const tcu::Matrix<T, Rows, Cols>& a, const tcu::Matrix<T, Rows, Cols>& b)
626 tcu::Matrix<T, Rows, Cols> retVal;
629 for (int c = 0; c < Cols; ++c)
637 template <typename T, int Rows, int Cols>
638 tcu::Matrix<T, Cols, Rows> transpose (const tcu::Matrix<T, Rows, Cols>& mat)
640 tcu::Matrix<T, Cols, Rows> retVal
    [all...]
  /external/eigen/unsupported/Eigen/src/MatrixFunctions/
MatrixPower.h 32 Index cols() const { return m_pow.cols(); } function in class:Eigen::MatrixPowerRetval
74 { eigen_assert(T.rows() == T.cols()); }
100 res = (MatrixType::Identity(IminusT.rows(), IminusT.cols()) + res).template triangularView<Upper>()
103 res += MatrixType::Identity(IminusT.rows(), IminusT.cols());
115 for (Index i=1; i < m_A.cols(); ++i) {
154 for (Index i=0; i < m_A.cols(); ++i)
158 IminusT = MatrixType::Identity(m_A.rows(), m_A.cols()) - T;
297 { eigen_assert(A.rows() == A.cols()); }
320 Index cols() const { return m_A.cols(); function in class:Eigen::MatrixPower
482 Index cols() const { return m_A.cols(); } function in class:Eigen::MatrixPowerReturnValue
    [all...]
  /external/eigen/Eigen/src/Core/util/
XprHelper.h 127 template<typename Scalar, int Rows, int Cols, int Options, int MaxRows, int MaxCols>
238 Cols = traits<T>::ColsAtCompileTime,
244 Cols,
256 Cols = traits<T>::ColsAtCompileTime,
262 Cols,
  /external/eigen/unsupported/Eigen/src/LevenbergMarquardt/
LMqrsolv.h 22 template <typename Scalar,int Rows, int Cols, typename Index>
24 Matrix<Scalar,Rows,Cols> &s,
35 Index n = s.cols();
115 Index n = s.cols();
  /external/eigen/unsupported/Eigen/src/KroneckerProduct/
KroneckerTensorProduct.h 47 inline Index cols() const { return m_A.cols() * m_B.cols(); } 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());
95 inline Index cols() const { return m_A.cols() * m_B.cols(); } function in class:Eigen::KroneckerProductSparse
117 Bc = m_B.cols();
119 for (Index j=0; j < m_A.cols(); ++j
    [all...]

Completed in 2393 milliseconds

1 2