HomeSort by relevance Sort by last modified time
    Searched refs:Real (Results 151 - 175 of 187) sorted by null

1 2 3 4 5 67 8

  /external/eigen/Eigen/src/Eigenvalues/
RealSchur.h 23 * \brief Performs a real Schur decomposition of a square matrix
26 * real Schur decomposition; this is expected to be an instantiation of the
29 * Given a real square matrix A, this class computes the real Schur
30 * decomposition: \f$ A = U T U^T \f$ where U is a real orthogonal matrix and
31 * T is a real quasi-triangular matrix. An orthogonal matrix is a matrix whose
36 * A, and thus the real Schur decomposition is used in EigenSolver to compute
39 * Call the function compute() to compute the real Schur decomposition of a
41 * constructor which computes the real Schur decomposition at construction
66 typedef std::complex<typename NumTraits<Scalar>::Real> ComplexScalar
    [all...]
SelfAdjointEigenSolver.h 36 * A matrix \f$ A \f$ is selfadjoint if it equals its adjoint. For real
41 * selfadjoint matrix are always real. If \f$ D \f$ is a diagonal matrix with
84 /** \brief Real scalar type for \p _MatrixType.
86 * This is just \c Scalar if #Scalar is real (e.g., \c float or
87 * \c double), and the type of the real part of \c Scalar if #Scalar is
90 typedef typename NumTraits<Scalar>::Real RealScalar;
398 m_eivalues.coeffRef(0,0) = numext::real(matrix.coeff(0,0));
505 // real-valued, because the matrix is symmetric.
RealQZ.h 20 * \brief Performs a real QZ decomposition of a pair of square matrices
23 * real QZ decomposition; this is expected to be an instantiation of the
26 * Given a real square matrices A and B, this class computes the real QZ
28 * real orthogonal matrixes, T is upper-triangular matrix, and S is upper
38 * Call the function compute() to compute the real QZ decomposition of a
41 * constructor which computes the real QZ decomposition at construction
69 typedef std::complex<typename NumTraits<Scalar>::Real> ComplexScalar;
96 /** \brief Constructor; computes real QZ decomposition of given matrices
309 /** \internal decouple 2x2 diagonal block in rows i, i+1 if eigenvalues are real */
    [all...]
  /external/eigen/Eigen/src/LU/
FullPivLU.h 58 typedef typename NumTraits<typename MatrixType::Scalar>::Real RealScalar;
  /external/eigen/bench/
bench_gemm.cpp 18 typedef NumTraits<Scalar>::Real RealScalar;
20 typedef Matrix</*Real*/Scalar,Dynamic,Dynamic> B;
203 std::cout << "blas real " << tblas.best(REAL_TIMER)/rep << "s \t" << (double(m)*n*p*rep*2/tblas.best(REAL_TIMER))*1e-9 << " GFLOPS \t(" << tblas.total(REAL_TIMER) << "s)\n";
210 std::cout << "eigen real " << tmt.best(REAL_TIMER)/rep << "s \t" << (double(m)*n*p*rep*2/tmt.best(REAL_TIMER))*1e-9 << " GFLOPS \t(" << tmt.total(REAL_TIMER) << "s)\n";
221 std::cout << "eigen mono real " << tmono.best(REAL_TIMER)/rep << "s \t" << (double(m)*n*p*rep*2/tmono.best(REAL_TIMER))*1e-9 << " GFLOPS \t(" << tmono.total(REAL_TIMER) << "s)\n";
239 std::cout << "\"matlab\" real " << t.best(REAL_TIMER)/rep << "s \t" << (double(m)*n*p*rep*2/t.best(REAL_TIMER))*1e-9 << " GFLOPS \t(" << t.total(REAL_TIMER) << "s)\n";
252 std::cout << "\"matlab\" real " << t.best(REAL_TIMER)/rep << "s \t" << (double(m)*n*p*rep*2/t.best(REAL_TIMER))*1e-9 << " GFLOPS \t(" << t.total(REAL_TIMER) << "s)\n";
265 std::cout << "\"matlab\" real " << t.best(REAL_TIMER)/rep << "s \t" << (double(m)*n*p*rep*2/t.best(REAL_TIMER))*1e-9 << " GFLOPS \t(" << t.total(REAL_TIMER) << "s)\n";
  /external/eigen/test/
array_for_matrix.cpp 78 typedef typename NumTraits<Scalar>::Real RealScalar;
  /external/eigen/unsupported/Eigen/src/Eigenvalues/
ArpackSelfAdjointEigenSolver.h 49 /** \brief Real scalar type for \p MatrixType.
51 * This is just \c Scalar if #Scalar is real (e.g., \c float or
52 * \c Scalar), and the type of the real part of \c Scalar if #Scalar is
55 typedef typename NumTraits<Scalar>::Real RealScalar;
  /external/llvm/tools/llvm-mc/
llvm-mc.cpp 266 case AsmToken::Real:
267 Out->os() << "real: " << Lexer.getTok().getString();
  /build/core/
envsetup.mk 55 # BUILD_OS is the real host doing the build.
131 # We'll substitute with the real value after loading BoardConfig.mk.
149 # Real boards should always be associated with an OEM vendor.
170 # Now we can substitute with the real value of TARGET_COPY_OUT_VENDOR
  /external/eigen/Eigen/src/Core/
PlainObjectBase.h 99 typedef typename NumTraits<Scalar>::Real RealScalar;
    [all...]
  /external/eigen/Eigen/src/Eigen2Support/Geometry/
Transform.h 270 bool isApprox(const Transform& other, typename NumTraits<Scalar>::Real prec = precision<Scalar>()) const
  /external/eigen/Eigen/src/Eigen2Support/
SVD.h 24 * This class performs a standard SVD decomposition of a real matrix A of size \c M x \c N
34 typedef typename NumTraits<typename MatrixType::Scalar>::Real RealScalar;
  /external/eigen/Eigen/src/Geometry/
Quaternion.h 43 typedef typename NumTraits<Scalar>::Real RealScalar;
246 * \warning Note the order of the arguments: the real \a w coefficient first,
Transform.h 587 bool isApprox(const Transform& other, const typename NumTraits<Scalar>::Real& prec = NumTraits<Scalar>::dummy_precision()) const
    [all...]
  /external/eigen/Eigen/src/SVD/
JacobiSVD.h 422 m << numext::real(matrix.coeff(p,p)), numext::real(matrix.coeff(p,q)),
423 numext::real(matrix.coeff(q,p)), numext::real(matrix.coeff(q,q));
460 * where \a U is a n-by-n unitary, \a V is a p-by-p unitary, and \a S is a n-by-p real positive matrix which is zero outside of its main diagonal;
506 typedef typename NumTraits<typename MatrixType::Scalar>::Real RealScalar;
    [all...]
  /external/eigen/unsupported/Eigen/src/SVD/
BDCSVD.h 48 typedef typename NumTraits<typename MatrixType::Scalar>::Real RealScalar;
320 temp.real() = naiveU;
336 temp.real() = naiveV;
382 if (compU) m_naiveU.block(firstCol, firstCol, n + 1, n + 1).real() << b.matrixU();
385 m_naiveU.row(0).segment(firstCol, n + 1).real() << b.matrixU().row(0);
386 m_naiveU.row(1).segment(firstCol, n + 1).real() << b.matrixU().row(n);
388 if (compV) m_naiveV.block(firstRowW, firstColW, n, n).real() << b.matrixV();
475 m_computed.col(firstCol + shift).segment(firstCol + shift + 1, k) << alphaK * l.transpose().real();
476 m_computed.col(firstCol + shift).segment(firstCol + shift + k + 1, n - k - 1) << betaK * f.transpose().real();
485 // Third part of the algorithm, since the real third part of the algorithm is not implemeted we use a JacobiSV
    [all...]
JacobiSVD.h 416 m << numext::real(matrix.coeff(p,p)), numext::real(matrix.coeff(p,q)),
417 numext::real(matrix.coeff(q,p)), numext::real(matrix.coeff(q,q));
452 * where \a U is a n-by-n unitary, \a V is a p-by-p unitary, and \a S is a n-by-p real positive matrix which is zero outside of its main diagonal;
499 typedef typename NumTraits<typename MatrixType::Scalar>::Real RealScalar;
  /external/llvm/lib/Target/AArch64/AsmParser/
AArch64AsmParser.cpp 688 // Otherwise it should be a real immediate in range:
    [all...]
  /prebuilts/python/darwin-x86/2.7.5/lib/python2.7/test/
test_decimal.py     [all...]
  /prebuilts/python/linux-x86/2.7.5/lib/python2.7/test/
test_decimal.py     [all...]
  /external/clang/lib/AST/
ExprConstant.cpp     [all...]
  /external/clang/include/clang/AST/
DataRecursiveASTVisitor.h 44 OPERATOR(Not) OPERATOR(LNot) OPERATOR(Real) OPERATOR(Imag) \
    [all...]
  /external/clang/lib/CodeGen/
CGCall.cpp 644 llvm::Value *RealAddr = Builder.CreateStructGEP(LV.getAddress(), 0, "real");
    [all...]
  /external/eigen/blas/testing/
dblat1.f 92 99999 FORMAT (' Real BLAS Test Program Results',/1X)
670 CALL TESTDSDOT(REAL(DSDOT(N,REAL(SX),INCX,REAL(SY),INCY)),
671 $ REAL(DT7(KN,KI)),REAL(SSIZE1(KN)), .3125E-1)
    [all...]
sblat1.f 19 *> Test program for the REAL Level 1 BLAS.
54 REAL SFAC
92 99999 FORMAT (' Real BLAS Test Program Results',/1X)
131 REAL SFAC
136 REAL D12, SA, SB, SC, SS
139 REAL DA1(8), DATRUE(8), DB1(8), DBTRUE(8), DC1(8),
247 REAL SFAC
254 REAL DTRUE1(5), DTRUE3(5), DTRUE5(8,5,2), DV(8,5,2),
258 REAL SASUM, SNRM2
341 REAL SFA
    [all...]

Completed in 1373 milliseconds

1 2 3 4 5 67 8