/external/cblas/src/ |
cblas_chpmv.c | 14 const void *alpha, const void *AP, 32 const float *xx= (float *)X, *alp= (float *)alpha, *bet = (float *)beta; 33 float ALPHA[2],BETA[2]; 55 F77_chpmv(F77_UL, &F77_N, alpha, AP, X, 61 ALPHA[0]= *alp; 62 ALPHA[1]= -alp[1]; 131 F77_chpmv(F77_UL, &F77_N, ALPHA,
|
cblas_zhbmv.c | 14 const void *alpha, const void *A, const int lda, 34 const double *xx= (double *)X, *alp= (double *)alpha, *bet = (double *)beta; 35 double ALPHA[2],BETA[2]; 57 F77_zhbmv(F77_UL, &F77_N, &F77_K, alpha, A, &F77_lda, X, 63 ALPHA[0]= *alp; 64 ALPHA[1]= -alp[1]; 131 F77_zhbmv(F77_UL, &F77_N, &F77_K, ALPHA,
|
cblas_zhemv.c | 14 const void *alpha, const void *A, const int lda, 33 const double *xx= (double *)X, *alp= (double *)alpha, *bet = (double *)beta; 34 double ALPHA[2],BETA[2]; 57 F77_zhemv(F77_UL, &F77_N, alpha, A, &F77_lda, X, &F77_incX, 63 ALPHA[0]= *alp; 64 ALPHA[1]= -alp[1]; 132 F77_zhemv(F77_UL, &F77_N, ALPHA, A, &F77_lda, x, &F77_incX,
|
cblas_zhpmv.c | 14 const void *alpha, const void *AP, 32 const double *xx= (double *)X, *alp= (double *)alpha, *bet = (double *)beta; 33 double ALPHA[2],BETA[2]; 55 F77_zhpmv(F77_UL, &F77_N, alpha, AP, X, 61 ALPHA[0]= *alp; 62 ALPHA[1]= -alp[1]; 131 F77_zhpmv(F77_UL, &F77_N, ALPHA,
|
/external/regex-re2/re2/testing/ |
exhaustive3_test.cc | 69 "[[:alnum:]] [[:alpha:]] [[:blank:]] [[:cntrl:]] [[:digit:]] " 82 "[[:alnum:]] [[:alpha:]] [[:blank:]] [[:cntrl:]] [[:digit:]] " 86 vector<string> alpha = InterestingUTF8(); local 87 for (int i = 0; i < alpha.size(); i++) 88 alpha[i] = "a" + alpha[i] + "b"; 90 1, alpha, "a%sb", "");
|
/frameworks/base/core/java/android/view/ |
RoundScrollbarRenderer.java | 57 public void drawRoundScrollbars(Canvas canvas, float alpha, Rect bounds) { 58 if (alpha == 0) { 73 setThumbColor(applyAlpha(DEFAULT_THUMB_COLOR, alpha)); 74 setTrackColor(applyAlpha(DEFAULT_TRACK_COLOR, alpha)); 107 private static int applyAlpha(int color, float alpha) { 108 int alphaByte = (int) (Color.alpha(color) * alpha);
|
/frameworks/base/packages/SystemUI/src/com/android/systemui/recents/views/ |
AnimateableViewBounds.java | 74 * Sets the view outline alpha. 76 void setAlpha(float alpha) { 77 if (Float.compare(alpha, mAlpha) != 0) { 78 mAlpha = alpha; 79 // TODO, If both clip and alpha change in the same frame, only invalidate once 85 * @return the outline alpha. 119 // TODO, If both clip and alpha change in the same frame, only invalidate once
|
/system/core/libpixelflinger/arch-arm64/ |
col32cb16blend.S | 34 // This function alpha blends a fixed color into a destination scanline, using 41 // a is the alpha channel of the source color. 51 lsr w5, w1, #24 // shift down alpha 55 sub w5, w4, w5 // invert alpha 71 madd w6, w6, w5, w10 // dest red * alpha + src red 72 madd w7, w7, w5, w12 // dest green * alpha + src green 73 madd w8, w8, w5, w4 // dest blue * alpha + src blue
|
/toolchain/binutils/binutils-2.25/bfd/po/ |
bfd.pot | 48 #: aoutx.h:1579 vms-alpha.c:7564 206 #: coff-alpha.c:452 208 "%B: Cannot handle compressed Alpha binaries.\n" 212 #: coff-alpha.c:603 216 #: coff-alpha.c:852 coff-alpha.c:889 coff-alpha.c:1973 coff-mips.c:946 220 #: coff-alpha.c:1450 224 #: coff-alpha.c:1509 228 #: coff-alpha.c:151 [all...] |
/external/eigen/Eigen/src/Core/products/ |
TriangularMatrixVector_BLAS.h | 54 const Scalar* _rhs, Index rhsIncr, Scalar* _res, Index resIncr, Scalar alpha) { \ 56 _rows, _cols, _lhs, lhsStride, _rhs, rhsIncr, _res, resIncr, alpha); \ 62 const Scalar* _rhs, Index rhsIncr, Scalar* _res, Index resIncr, Scalar alpha) { \ 64 _rows, _cols, _lhs, lhsStride, _rhs, rhsIncr, _res, resIncr, alpha); \ 73 // implements col-major: res += alpha * op(triangular) * vector 85 const EIGTYPE* _rhs, Index rhsIncr, EIGTYPE* _res, Index resIncr, EIGTYPE alpha) \ 89 _rows, _cols, _lhs, lhsStride, _rhs, rhsIncr, _res, resIncr, alpha); \ 127 BLASPREFIX##axpy_(&n, &numext::real_ref(alpha),(const BLASTYPE*)x, &incx, (BLASTYPE*)_res, &incy); \ 145 BLASPREFIX##gemv_(&trans, &m, &n, &numext::real_ref(alpha), (const BLASTYPE*)a, &lda, (const BLASTYPE*)x, &incx, &numext::real_ref(beta), (BLASTYPE*)y, &incy); \ 155 // implements row-major: res += alpha * op(triangular) * vecto [all...] |
SelfadjointProduct.h | 25 static void run(Index size, Scalar* mat, Index stride, const Scalar* vecX, const Scalar* vecY, const Scalar& alpha) 33 += (alpha * cj(vecY[i])) * ConjLhsType(OtherMap(vecX+(UpLo==Lower ? i : 0),UpLo==Lower ? size-i : (i+1))); 41 static void run(Index size, Scalar* mat, Index stride, const Scalar* vecX, const Scalar* vecY, const Scalar& alpha) 43 selfadjoint_rank1_update<Scalar,Index,ColMajor,UpLo==Lower?Upper:Lower,ConjRhs,ConjLhs>::run(size,mat,stride,vecY,vecX,alpha); 53 static void run(MatrixType& mat, const OtherType& other, const typename MatrixType::Scalar& alpha) 61 Scalar actualAlpha = alpha * OtherBlasTraits::extractScalarFactor(other.derived()); 85 static void run(MatrixType& mat, const OtherType& other, const typename MatrixType::Scalar& alpha) 93 Scalar actualAlpha = alpha * OtherBlasTraits::extractScalarFactor(other.derived()); 124 ::rankUpdate(const MatrixBase<DerivedU>& u, const Scalar& alpha) 126 selfadjoint_product_selector<MatrixType,DerivedU,UpLo>::run(_expression().const_cast_derived(), u.derived(), alpha); local [all...] |
/external/libpng/contrib/pngminus/ |
png2pnm.c | 56 BOOL alpha); 68 BOOL alpha = FALSE; local 84 alpha = TRUE; 89 fprintf (stderr, "Error: can not create alpha-channel file %s\n", 147 if (png2pnm (fp_rd, fp_wr, fp_al, raw, alpha) == FALSE) 158 /* close alpha file */ 159 if (alpha) 185 " -a[lpha] <file>.pgm write PNG alpha channel as pgm-file\n"); 194 volatile BOOL raw, BOOL alpha) 264 /* transform transparency maps into full alpha-channel * [all...] |
/external/skia/src/core/ |
SkSpriteBlitter_RGB16.cpp | 74 #define SkSPRITE_ARGS , uint8_t alpha 76 #define SkSPRITE_INIT fSrcAlpha = alpha; 117 #define SkSPRITE_ARGS , uint8_t alpha 119 #define SkSPRITE_INIT fSrcAlpha = alpha; 147 #define SkSPRITE_ARGS , uint8_t alpha 149 #define SkSPRITE_INIT fSrcAlpha = alpha; 239 #define SkSPRITE_ARGS , uint8_t alpha 241 #define SkSPRITE_INIT fSrcAlpha = alpha; 281 U8CPU alpha = fPaint->getAlpha(); variable 284 proc(dst, src, width, alpha, x, y) 317 unsigned alpha = paint.getAlpha(); local [all...] |
/external/speex/libspeex/ |
scal.c | 76 float *alpha; member in struct:SpeexDecorrState_ 99 st->alpha = speex_alloc(channels*sizeof(float)); 113 st->alpha[ch] = 0; 160 float alpha; local 166 alpha = st->alpha[ch]; 185 st->y[i] = alpha*(x[i-ALLPASS_ORDER+order]-beta*x[i-ALLPASS_ORDER+order-1])*st->vorbis_win[st->frame_size+i+order] 187 - alpha*(ring[ringID] 204 alpha = alpha + .4*uni_rand(&st->seed) [all...] |
/frameworks/av/media/libstagefright/codecs/amrwbenc/src/ |
levinson.c | 35 * Alpha prediction gain. * 41 * Alpha = R[0] * (1-K**2] * 47 * K = -S / Alpha * 53 * Alpha=Alpha * (1-K**2) * 69 * The K[i] and Alpha are theoretically < 1.0. * 79 * Alpha Normalized -> mantissa in Q31 plus exponent * 87 * necessarily < 1.0 as both the K[i] and Alpha are * 144 /* Alpha = R[0] * (1-K**2) */ 152 t0 = Mpy_32(Rh[0], Rl[0], hi, lo); /* Alpha in Q31 * [all...] |
/external/eigen/blas/f2c/ |
chbmv.c | 16 alpha, complex *a, integer *lda, complex *x, integer *incx, complex * 44 /* y := alpha*A*x + beta*y, */ 46 /* where alpha and beta are scalars, x and y are n element vectors and */ 75 /* ALPHA - COMPLEX . */ 76 /* On entry, ALPHA specifies the scalar alpha. */ 207 if (*n == 0 || (alpha->r == 0.f && alpha->i == 0.f && (beta->r == 1.f && 276 if (alpha->r == 0.f && alpha->i == 0.f) [all...] |
chpmv.c | 15 /* Subroutine */ int chpmv_(char *uplo, integer *n, complex *alpha, complex * 43 /* y := alpha*A*x + beta*y, */ 45 /* where alpha and beta are scalars, x and y are n element vectors and */ 69 /* ALPHA - COMPLEX . */ 70 /* On entry, ALPHA specifies the scalar alpha. */ 166 if (*n == 0 || (alpha->r == 0.f && alpha->i == 0.f && (beta->r == 1.f && 235 if (alpha->r == 0.f && alpha->i == 0.f) [all...] |
zhbmv.c | 16 *alpha, doublecomplex *a, integer *lda, doublecomplex *x, integer * 45 /* y := alpha*A*x + beta*y, */ 47 /* where alpha and beta are scalars, x and y are n element vectors and */ 76 /* ALPHA - COMPLEX*16 . */ 77 /* On entry, ALPHA specifies the scalar alpha. */ 208 if (*n == 0 || (alpha->r == 0. && alpha->i == 0. && (beta->r == 1. && 277 if (alpha->r == 0. && alpha->i == 0.) [all...] |
zhpmv.c | 15 /* Subroutine */ int zhpmv_(char *uplo, integer *n, doublecomplex *alpha, 43 /* y := alpha*A*x + beta*y, */ 45 /* where alpha and beta are scalars, x and y are n element vectors and */ 69 /* ALPHA - COMPLEX*16 . */ 70 /* On entry, ALPHA specifies the scalar alpha. */ 166 if (*n == 0 || (alpha->r == 0. && alpha->i == 0. && (beta->r == 1. && 235 if (alpha->r == 0. && alpha->i == 0.) [all...] |
/external/eigen/Eigen/src/SparseCore/ |
SparseDenseProduct.h | 34 static void run(const SparseLhsType& lhs, const DenseRhsType& rhs, DenseResType& res, const typename Res::Scalar& alpha) 53 processRow(lhsEval,rhs,res,alpha,i,c); 59 processRow(lhsEval,rhs,res,alpha,i,c); 64 static void processRow(const LhsEval& lhsEval, const DenseRhsType& rhs, DenseResType& res, const typename Res::Scalar& alpha, Index i, Index col) 69 res.coeffRef(i,col) += alpha * tmp; 92 static void run(const SparseLhsType& lhs, const DenseRhsType& rhs, DenseResType& res, const AlphaType& alpha) 99 // typename Res::Scalar rhs_j = alpha * rhs.coeff(j,c); 100 typename ScalarBinaryOpTraits<AlphaType, typename Rhs::Scalar>::ReturnType rhs_j(alpha * rhs.coeff(j,c)); 115 static void run(const SparseLhsType& lhs, const DenseRhsType& rhs, DenseResType& res, const typename Res::Scalar& alpha) 122 res_j += (alpha*it.value()) * rhs.row(it.index()) [all...] |
/external/eigen/blas/ |
level3_impl.h | 44 Scalar alpha = *reinterpret_cast<const Scalar*>(palpha); local 74 func[code](*m, *n, *k, a, *lda, b, *ldb, c, *ldc, alpha, blocking, 0); 144 Scalar alpha = *reinterpret_cast<const Scalar*>(palpha); local 174 if(alpha!=Scalar(1)) 175 matrix(b,*m,*n,*ldb) *= alpha; 181 // b = alpha*op(a)*b for side = 'L'or'l' 182 // b = alpha*b*op(a) for side = 'R'or'r' 249 Scalar alpha = *reinterpret_cast<const Scalar*>(palpha); local 275 func[code](*m, *n, *m, a, *lda, tmp.data(), tmp.outerStride(), b, *ldb, alpha, blocking); 280 func[code](*m, *n, *n, tmp.data(), tmp.outerStride(), a, *lda, b, *ldb, alpha, blocking) 294 Scalar alpha = *reinterpret_cast<const Scalar*>(palpha); local 383 Scalar alpha = *reinterpret_cast<const Scalar*>(palpha); local 443 Scalar alpha = *reinterpret_cast<const Scalar*>(palpha); local 511 Scalar alpha = *reinterpret_cast<const Scalar*>(palpha); local 587 RealScalar alpha = *palpha; local 637 Scalar alpha = *reinterpret_cast<const Scalar*>(palpha); local [all...] |
/external/freetype/src/sfnt/ |
pngshim.c | 41 multiply_alpha( unsigned int alpha, 44 unsigned int temp = alpha * color + 0x80; 65 unsigned int alpha = base[3]; local 68 if ( alpha == 0 ) 78 if ( alpha != 0xFF ) 80 red = multiply_alpha( alpha, red ); 81 green = multiply_alpha( alpha, green ); 82 blue = multiply_alpha( alpha, blue ); 88 base[3] = (unsigned char)alpha; 293 /* transform transparency to alpha */ [all...] |
/external/pdfium/third_party/freetype/src/sfnt/ |
pngshim.c | 41 multiply_alpha( unsigned int alpha, 44 unsigned int temp = alpha * color + 0x80; 65 unsigned int alpha = base[3]; local 68 if ( alpha == 0 ) 78 if ( alpha != 0xFF ) 80 red = multiply_alpha( alpha, red ); 81 green = multiply_alpha( alpha, green ); 82 blue = multiply_alpha( alpha, blue ); 88 base[3] = (unsigned char)alpha; 302 /* transform transparency to alpha */ [all...] |
/external/skia/include/gpu/ |
GrBlend.h | 16 * Equations for alpha-blending. 49 * Coefficients for alpha-blending. 58 kSA_GrBlendCoeff, //<! src alpha 59 kISA_GrBlendCoeff, //<! one minus src alpha 60 kDA_GrBlendCoeff, //<! dst alpha 61 kIDA_GrBlendCoeff, //<! one minus dst alpha 64 kConstA_GrBlendCoeff, //<! constant color alpha 65 kIConstA_GrBlendCoeff, //<! one minus constant color alpha 193 * Advanced blend equations can always tweak alpha for coverage. (See GrCustomXfermode.cpp) 200 * (Let srcCoeff be negative for reverse subtract.) We can tweak alpha for coverage when th [all...] |
/external/skia/src/effects/ |
SkEmbossMask.cpp | 95 uint8_t* alpha = mask->fImage; local 96 uint8_t* multiply = (uint8_t*)alpha + planeSize; 108 if (alpha[x]) { 109 int nx = alpha[x + neq_to_one(x, maxx)] - alpha[x - nonzero_to_one(x)]; 110 int ny = alpha[x + next_row] - alpha[x - prev_row]; 155 // ((uint8_t*)alpha)[x] = alpha[x] * multiply[x] >> 8; 158 alpha += rowBytes [all...] |