Searched refs:tau (Results 1 - 17 of 17) sorted by relevance

/external/eigen/Eigen/src/Householder/
H A DHouseholder.h28 * \f$ H = I - tau v v^*\f$
35 * \param tau the scaling factor of the Householder transformation
42 void MatrixBase<Derived>::makeHouseholderInPlace(Scalar& tau, RealScalar& beta) argument
45 makeHouseholder(essentialPart, tau, beta);
51 * \f$ H = I - tau v v^*\f$
57 * \param tau the scaling factor of the Householder transformation
67 Scalar& tau,
81 tau = RealScalar(0);
91 tau = conj((beta - c0) / beta);
96 * \f$ H = I - tau
65 makeHouseholder( EssentialPart& essential, Scalar& tau, RealScalar& beta) const argument
112 applyHouseholderOnTheLeft( const EssentialPart& essential, const Scalar& tau, Scalar* workspace) argument
149 applyHouseholderOnTheRight( const EssentialPart& essential, const Scalar& tau, Scalar* workspace) argument
[all...]
/external/compiler-rt/lib/builtins/ppc/
H A Dgcc_qmul.c21 double ab, tmp, tau; local
47 tau = ab + tmp;
49 dst.s.lo = (ab - tau) + tmp;
50 dst.s.hi = tau;
/external/eigen/bench/btl/libs/BLAS/
H A Dblas_interface.hh32 void ssytrd_(char *uplo, const int *n, float *a, const int *lda, float *d, float *e, float *tau, float *work, int *lwork, int *info );
33 void dsytrd_(char *uplo, const int *n, double *a, const int *lda, double *d, double *e, double *tau, double *work, int *lwork, int *info );
34 void sgehrd_( const int *n, int *ilo, int *ihi, float *a, const int *lda, float *tau, float *work, int *lwork, int *info );
35 void dgehrd_( const int *n, int *ilo, int *ihi, double *a, const int *lda, double *tau, double *work, int *lwork, int *info );
/external/clang/test/SemaTemplate/
H A Dinstantiate-var-template.cpp5 template <typename T> constexpr T tau = 2 * pi<T>; member in namespace:PR17846
6 constexpr double tau_double = tau<double>;
/external/srec/srec/clib/
H A Djacobi.c39 double tau);
56 double g, thresh, sum, c, s, t, tau, h; local
135 tau = s / (1.0 + c);
144 for (k = 0 ; k < i; k++) Rotate(a, dim, k, i, k, j, s, tau);
145 for (k = i + 1; k < j; k++) Rotate(a, dim, i, k, k, j, s, tau);
146 for (k = j + 1; k < dim; k++) Rotate(a, dim, i, k, j, k, s, tau);
148 for (k = 0; k < dim; k++) Rotate(v, dim, k, i, k, j, s, tau);
194 double tau)
199 a[i][j] = g - s * (h + g * tau);
200 a[k][l] = h + s * (g - h * tau);
193 Rotate(double **a, int dim, int i, int j, int k, int l, double s, double tau) argument
[all...]
/external/eigen/unsupported/Eigen/src/IterativeSolvers/
H A DGMRES.h84 VectorType tau = VectorType::Zero(restart + 1); local
90 r0.makeHouseholder(e, tau.coeffRef(0), beta);
102 v.tail(m - i).applyHouseholderOnTheLeft(H.col(i).tail(m - i - 1), tau.coeffRef(i), workspace.data());
111 v.tail(m - i).applyHouseholderOnTheLeft(H.col(i).tail(m - i - 1), tau.coeffRef(i), workspace.data());
121 v.tail(m - k).makeHouseholder(e, tau.coeffRef(k), beta);
125 v.tail(m - k).applyHouseholderOnTheLeft(H.col(k).tail(m - k - 1), tau.coeffRef(k), workspace.data());
162 x_new.tail(m - k + 1).applyHouseholderOnTheLeft(H.col(k - 1).tail(m - k), tau.coeffRef(k - 1), workspace.data());
167 x_new.tail(m - i).applyHouseholderOnTheLeft(H.col(i).tail(m - i - 1), tau.coeffRef(i), workspace.data());
184 tau = VectorType::Zero(restart + 1);
188 r0.makeHouseholder(e, tau
[all...]
/external/eigen/Eigen/src/SparseQR/
H A DSparseQR.h430 // Then update tval = tval - q * tau
450 Scalar tau; local
464 tau = RealScalar(0);
477 tau = numext::conj((beta-c0) / beta);
497 m_hcoeffs(nonzeroCol) = tau;
601 Scalar tau = Scalar(0); local
602 tau = m_qr.m_Q.col(k).dot(res.col(j));
603 if(tau==Scalar(0)) continue;
604 tau = tau * m_q
617 Scalar tau = Scalar(0); local
[all...]
/external/eigen/Eigen/src/Eigenvalues/
H A DRealSchur.h485 Scalar tau, beta; local
487 v.makeHouseholder(ess, tau, beta);
497 m_matT.block(k, k, 3, size-k).applyHouseholderOnTheLeft(ess, tau, workspace);
498 m_matT.block(0, k, (std::min)(iu,k+3) + 1, 3).applyHouseholderOnTheRight(ess, tau, workspace);
500 m_matU.block(0, k, size, 3).applyHouseholderOnTheRight(ess, tau, workspace);
505 Scalar tau, beta; local
507 v.makeHouseholder(ess, tau, beta);
512 m_matT.block(iu-1, iu-1, 2, size-iu+1).applyHouseholderOnTheLeft(ess, tau, workspace);
513 m_matT.block(0, iu-1, iu+1, 2).applyHouseholderOnTheRight(ess, tau, workspace);
515 m_matU.block(0, iu-1, size, 2).applyHouseholderOnTheRight(ess, tau, workspac
[all...]
H A DRealQZ.h478 Scalar tau, beta; local
483 hr.makeHouseholderInPlace(tau, beta);
486 m_S.template middleRows<3>(k).rightCols(dim-fc).applyHouseholderOnTheLeft(essential2, tau, m_workspace.data());
487 m_T.template middleRows<3>(k).rightCols(dim-fc).applyHouseholderOnTheLeft(essential2, tau, m_workspace.data());
489 m_Q.template middleCols<3>(k).applyHouseholderOnTheRight(essential2, tau, m_workspace.data());
495 hr.makeHouseholderInPlace(tau, beta);
503 m_S.col(k+2).head(lr) -= tau*tmp;
504 m_S.template middleCols<2>(k).topRows(lr) -= (tau*tmp) * essential2.adjoint();
508 m_T.col(k+2).head(lr) -= tau*tmp;
509 m_T.template middleCols<2>(k).topRows(lr) -= (tau*tm
[all...]
/external/chromium_org/third_party/opus/src/src/
H A Danalysis.c498 float tau; local
513 tau = .00005f*frame_probs[1];
525 p0 = (1-tonal->music_prob)*(1-tau) + tonal->music_prob *tau;
526 p1 = tonal->music_prob *(1-tau) + (1-tonal->music_prob)*tau;
550 tonal->pspeech[0] = s0*(1-tau)*speech0;
551 tonal->pmusic [0] = m0*(1-tau)*music0;
559 tonal->pspeech[DETECT_SIZE-1] = m0*tau*speech0;
561 tonal->pmusic [DETECT_SIZE-1] = s0*tau*music
[all...]
/external/libopus/src/
H A Danalysis.c498 float tau; local
513 tau = .00005f*frame_probs[1];
525 p0 = (1-tonal->music_prob)*(1-tau) + tonal->music_prob *tau;
526 p1 = tonal->music_prob *(1-tau) + (1-tonal->music_prob)*tau;
550 tonal->pspeech[0] = s0*(1-tau)*speech0;
551 tonal->pmusic [0] = m0*(1-tau)*music0;
559 tonal->pspeech[DETECT_SIZE-1] = m0*tau*speech0;
561 tonal->pmusic [DETECT_SIZE-1] = s0*tau*music
[all...]
/external/bouncycastle/bcprov/src/main/java/org/bouncycastle/math/ec/
H A DWTauNafMultiplier.java7 * <code>&tau;</code>-adic Non-Adjacent Form) algorithm.
13 * by <code>k</code> using the reduced <code>&tau;</code>-adic NAF (RTNAF)
41 * by an element <code>&lambda;</code> of <code><b>Z</b>[&tau;]</code> using
42 * the <code>&tau;</code>-adic NAF (TNAF) method.
45 * <code><b>Z</b>[&tau;]</code> of which to compute the
46 * <code>[&tau;]</code>-adic NAF.
73 * by an element <code>&lambda;</code> of <code><b>Z</b>[&tau;]</code>
74 * using the window <code>&tau;</code>-adic NAF (TNAF) method, given the
101 q = Tnaf.tau(q);
H A DTnaf.java7 * &tau;-adic nonadjacent form (WTNAF). The algorithms are based on the
76 * <code><b>Z</b>[&tau;]</code>.
79 * <code><b>Z</b>[&tau;]</code>.
113 * <code><b>R</b>[&tau;]</code>, where <code>&lambda; = u + v&tau;</code>
118 * <code><b>R</b>[&tau;]</code>.
119 * @param v The <code>&tau;</code>-adic part of the element
120 * <code>&lambda;</code> of <code><b>R</b>[&tau;]</code>.
154 * Rounds an element <code>&lambda;</code> of <code><b>R</b>[&tau;]</code>
155 * to an element of <code><b>Z</b>[&tau;]</cod
393 public static ECPoint.F2m tau(ECPoint.F2m p) method in class:Tnaf
[all...]
H A DECPoint.java1457 public ECPoint.F2m tau() method in class:ECPoint.F2m
/external/eigen/Eigen/src/Jacobi/
H A DJacobi.h96 RealScalar tau = (x-z)/(RealScalar(2)*abs(y)); local
97 RealScalar w = sqrt(numext::abs2(tau) + RealScalar(1));
99 if(tau>RealScalar(0))
101 t = RealScalar(1) / (tau + w);
105 t = RealScalar(1) / (tau - w);
/external/eigen/Eigen/src/Core/
H A DMatrixBase.h429 void makeHouseholderInPlace(Scalar& tau, RealScalar& beta);
432 Scalar& tau, RealScalar& beta) const;
435 const Scalar& tau,
439 const Scalar& tau,
/external/google-tv-pairing-protocol/java/jar/
H A Dbcprov-jdk15-143.jarMETA-INF/MANIFEST.MF META-INF/BCKEY.SF META-INF/BCKEY.DSA META ...

Completed in 819 milliseconds