Searched defs:alpha (Results 251 - 275 of 421) sorted by relevance

<<11121314151617

/external/skia/src/gpu/
H A DGrSWMaskHelper.cpp105 bool antiAlias, uint8_t alpha) {
114 paint.setColor(SkColorSetARGB(alpha, alpha, alpha, alpha));
125 bool antiAlias, uint8_t alpha) {
151 if (SkRegion::kReplace_Op == op && 0xFF == alpha) {
156 paint.setColor(SkColorSetARGB(alpha, alpha, alpha, alph
104 draw(const SkRect& rect, SkRegion::Op op, bool antiAlias, uint8_t alpha) argument
124 draw(const SkPath& path, const SkStrokeRec& stroke, SkRegion::Op op, bool antiAlias, uint8_t alpha) argument
[all...]
/external/skia/src/images/
H A DSkImageDecoder_libico.cpp261 // The AND mask is a 1-bit alpha mask for each pixel that comes after the
308 //check the alpha bit first, but pass it along to the function to figure out how to deal with it
399 //alphaBit == 1 => alpha = 0
400 int alpha = (alphaBit-1) & 0xFF; local
401 *address = SkPreMultiplyARGB(alpha, red, green, blue);
416 int alpha = readByte(buf, xorOffset + 4*pixelNo + 3) & ((alphaBit-1)&0xFF); local
417 *address = SkPreMultiplyARGB(alpha, red, green, blue);
/external/skia/src/opts/
H A DSkColor_opts_SSE2.h30 static inline __m128i SkAlpha255To256_SSE2(const __m128i& alpha) { argument
31 return _mm_add_epi32(alpha, _mm_set1_epi32(1));
84 #if SK_A32_SHIFT == 24 // It's very common (universal?) that alpha is the top byte.
230 // Fast path for SkBlendARGB32_SSE2 with a constant alpha factor.
233 unsigned alpha = SkAlpha255To256(aa); local
234 __m128i src_scale = _mm_set1_epi32(alpha);
241 __m128i result = SkAlphaMulQ_SSE2(src, alpha);
/external/skia/tests/
H A DBlitRowTest.cpp233 uint8_t alpha = (k & 2) ? 0x80 : 0xFF; local
235 paint.setAlpha(alpha);
251 " alpha=0x%x src=0x%x",
253 alpha, c);
/external/speex/libspeex/
H A Dscal.c76 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
[all...]
/external/webp/src/dsp/
H A Dalpha_processing.c35 { // (255u << MFIX) / alpha
79 { // alpha * KINV_255
141 if (argb < 0xff000000u) { // alpha < 255
142 if (argb <= 0x00ffffffu) { // alpha == 0
145 const uint32_t alpha = (argb >> 24) & 0xff; local
146 const uint32_t scale = GetScale(alpha, inverse);
157 static void MultRow(uint8_t* const ptr, const uint8_t* const alpha, argument
161 const uint32_t a = alpha[x];
178 void (*WebPMultRow)(uint8_t* const ptr, const uint8_t* const alpha,
194 const uint8_t* alpha, in
193 WebPMultRows(uint8_t* ptr, int stride, const uint8_t* alpha, int alpha_stride, int width, int num_rows, int inverse) argument
224 const uint8_t* const alpha = rgba + (alpha_first ? 0 : 3); local
287 ExtractAlpha(const uint8_t* argb, int argb_stride, int width, int height, uint8_t* alpha, int alpha_stride) argument
[all...]
/external/webp/src/enc/
H A Dpicture_tools.c10 // WebPPicture tools: alpha handling, etc.
150 const int alpha = a_ptr[x]; local
151 if (alpha < 0xff) {
162 // Average four alpha values into a single blending weight.
164 const int alpha = local
167 u[x] = BLEND_10BIT(U0, u[x], alpha);
168 v[x] = BLEND_10BIT(V0, v[x], alpha);
171 const int alpha = 2 * (a_ptr[2 * x + 0] + a_ptr2[2 * x + 0]); local
172 u[x] = BLEND_10BIT(U0, u[x], alpha);
173 v[x] = BLEND_10BIT(V0, v[x], alpha);
183 const int alpha = (argb[x] >> 24) & 0xff; local
[all...]
/external/apache-commons-math/src/main/java/org/apache/commons/math/geometry/
H A DVector3D.java104 * @param alpha azimuth (&alpha;) around Z
110 public Vector3D(double alpha, double delta) { argument
112 this.x = FastMath.cos(alpha) * cosDelta;
113 this.y = FastMath.sin(alpha) * cosDelta;
232 * @return azimuth (&alpha;) of the vector, between -&pi; and +&pi;
/external/apache-commons-math/src/main/java/org/apache/commons/math/random/
H A DRandomDataImpl.java532 * @param alpha first distribution shape parameter
534 * @return random value sampled from the beta(alpha, beta) distribution
538 public double nextBeta(double alpha, double beta) throws MathException { argument
539 return nextInversionDeviate(new BetaDistributionImpl(alpha, beta));
/external/deqp/modules/egl/
H A DteglMemoryStressTests.cpp222 const float alpha = m_rnd.getFloat(); local
226 m_gl.clearColor(red, green, blue, alpha);
286 const float alpha = m_rnd.getFloat(); local
290 m_gl.clearColor(red, green, blue, alpha);
/external/eigen/Eigen/src/Cholesky/
H A DLDLT.h209 LDLT& rankUpdate(const MatrixBase<Derived>& w, const RealScalar& alpha=1);
359 RealScalar alpha = 1; local
365 if (!(isfinite)(alpha))
372 RealScalar gamma = dj*alpha + swj2;
374 mat.coeffRef(j,j) += swj2/alpha;
375 alpha += swj2/dj;
/external/eigen/Eigen/src/Core/products/
H A DGeneralMatrixMatrixTriangular.h45 const RhsScalar* rhs, Index rhsStride, ResScalar* res, Index resStride, const ResScalar& alpha)
51 ::run(size,depth,rhs,rhsStride,lhs,lhsStride,res,resStride,alpha);
61 const RhsScalar* _rhs, Index rhsStride, ResScalar* res, Index resStride, const ResScalar& alpha)
105 gebp(res+i2, resStride, blockA, blockB, actual_mc, actual_kc, (std::min)(size,i2), alpha,
108 sybb(res+resStride*i2 + i2, resStride, blockA, blockB + actual_kc*i2, actual_mc, actual_kc, alpha, allocatedBlockB);
113 gebp(res+resStride*j2+i2, resStride, blockA, blockB+actual_kc*j2, actual_mc, actual_kc, (std::max)(Index(0), size-j2), alpha,
139 void operator()(ResScalar* res, Index resStride, const LhsScalar* blockA, const RhsScalar* blockB, Index size, Index depth, const ResScalar& alpha, RhsScalar* workspace) argument
152 gebp_kernel(res+j*resStride, resStride, blockA, actual_b, j, depth, actualBlockSize, alpha,
160 gebp_kernel(buffer.data(), BlockSize, blockA+depth*i, actual_b, actualBlockSize, depth, actualBlockSize, alpha,
175 gebp_kernel(res+j*resStride+i, resStride, blockA+depth*i, actual_b, size-i, depth, actualBlockSize, alpha,
44 run(Index size, Index depth,const LhsScalar* lhs, Index lhsStride, const RhsScalar* rhs, Index rhsStride, ResScalar* res, Index resStride, const ResScalar& alpha) argument
60 run(Index size, Index depth,const LhsScalar* _lhs, Index lhsStride, const RhsScalar* _rhs, Index rhsStride, ResScalar* res, Index resStride, const ResScalar& alpha) argument
193 run(MatrixType& mat, const ProductType& prod, const typename MatrixType::Scalar& alpha) argument
239 run(MatrixType& mat, const ProductType& prod, const typename MatrixType::Scalar& alpha) argument
269 assignProduct(const ProductBase<ProductDerived, _Lhs,_Rhs>& prod, const Scalar& alpha) argument
[all...]
H A DGeneralMatrixVector.h23 * Mixing type logic: C += alpha * A * B
24 * | A | B |alpha| comments
26 * |real |cplx |real | alpha is converted to a cplx when calling the run function, no vectorization
27 * |cplx |real |cplx | invalid, the caller has to do tmp: = A * B; C += alpha*tmp
55 ResScalar* res, Index resIncr, RhsScalar alpha);
63 ResScalar* res, Index resIncr, RhsScalar alpha)
82 alpha = numext::conj(alpha);
151 RhsPacket ptmp0 = pset1<RhsPacket>(alpha*rhs[i*rhsIncr]),
152 ptmp1 = pset1<RhsPacket>(alpha*rh
59 run( Index rows, Index cols, const LhsScalar* lhs, Index lhsStride, const RhsScalar* rhs, Index rhsIncr, ResScalar* res, Index resIncr, RhsScalar alpha) argument
323 run( Index rows, Index cols, const LhsScalar* lhs, Index lhsStride, const RhsScalar* rhs, Index rhsIncr, ResScalar* res, Index resIncr, ResScalar alpha) argument
[all...]
H A DTriangularMatrixVector.h30 const RhsScalar* _rhs, Index rhsIncr, ResScalar* _res, Index resIncr, const ResScalar& alpha);
36 const RhsScalar* _rhs, Index rhsIncr, ResScalar* _res, Index resIncr, const ResScalar& alpha)
63 res.segment(s,r) += (alpha * cjRhs.coeff(i)) * cjLhs.col(i).segment(s,r);
65 res.coeffRef(i) += alpha * cjRhs.coeff(i);
75 &res.coeffRef(s), resIncr, alpha);
84 _res, resIncr, alpha);
98 const RhsScalar* _rhs, Index rhsIncr, ResScalar* _res, Index resIncr, const ResScalar& alpha);
104 const RhsScalar* _rhs, Index rhsIncr, ResScalar* _res, Index resIncr, const ResScalar& alpha)
131 res.coeffRef(i) += alpha * (cjLhs.row(i).segment(s,r).cwiseProduct(cjRhs.segment(s,r).transpose())).sum();
133 res.coeffRef(i) += alpha * cjRh
35 run(Index _rows, Index _cols, const LhsScalar* _lhs, Index lhsStride, const RhsScalar* _rhs, Index rhsIncr, ResScalar* _res, Index resIncr, const ResScalar& alpha) argument
103 run(Index _rows, Index _cols, const LhsScalar* _lhs, Index lhsStride, const RhsScalar* _rhs, Index rhsIncr, ResScalar* _res, Index resIncr, const ResScalar& alpha) argument
207 TriangularProductTranspose(m_rhs.transpose(),m_lhs.transpose()), dstT, alpha); local
218 run(const TriangularProduct<Mode,true,Lhs,false,Rhs,true>& prod, Dest& dest, const typename TriangularProduct<Mode,true,Lhs,false,Rhs,true>::Scalar& alpha) argument
294 run(const TriangularProduct<Mode,true,Lhs,false,Rhs,true>& prod, Dest& dest, const typename TriangularProduct<Mode,true,Lhs,false,Rhs,true>::Scalar& alpha) argument
[all...]
/external/eigen/Eigen/src/SparseCore/
H A DSparseSelfAdjointView.h113 * \f$ this = this + \alpha ( u u^* ) \f$ where \a u is a vector or matrix.
117 * To perform \f$ this = this + \alpha ( u^* u ) \f$ you can simply
121 SparseSelfAdjointView& rankUpdate(const SparseMatrixBase<DerivedU>& u, const Scalar& alpha = Scalar(1));
200 SparseSelfAdjointView<MatrixType,UpLo>::rankUpdate(const SparseMatrixBase<DerivedU>& u, const Scalar& alpha) argument
203 if(alpha==Scalar(0))
206 m_matrix.const_cast_derived() += alpha * tmp.template triangularView<UpLo>();
234 template<typename Dest> void scaleAndAddTo(Dest& dest, const Scalar& alpha) const
236 EIGEN_ONLY_USED_FOR_DEBUG(alpha);
237 // TODO use alpha
238 eigen_assert(alpha
[all...]
/external/libavc/common/
H A Dih264_deblk_edge_filters.c83 /* alpha - alpha value for the boundary */
106 WORD32 alpha,
137 if((ABS(p0 - q0) >= alpha) ||
147 if(ABS(p0 - q0) < ((alpha >> 2) + 2))
203 /* alpha - alpha value for the boundary */
226 WORD32 alpha,
260 if((ABS(p0 - q0) >= alpha) ||
270 if(ABS(p0 - q0) < ((alpha >>
104 ih264_deblk_luma_vert_bs4(UWORD8 *pu1_src, WORD32 src_strd, WORD32 alpha, WORD32 beta) argument
224 ih264_deblk_luma_horz_bs4(UWORD8 *pu1_src, WORD32 src_strd, WORD32 alpha, WORD32 beta) argument
347 ih264_deblk_chroma_vert_bs4_bp(UWORD8 *pu1_src, WORD32 src_strd, WORD32 alpha, WORD32 beta) argument
437 ih264_deblk_chroma_horz_bs4_bp(UWORD8 *pu1_src, WORD32 src_strd, WORD32 alpha, WORD32 beta) argument
536 ih264_deblk_luma_vert_bslt4(UWORD8 *pu1_src, WORD32 src_strd, WORD32 alpha, WORD32 beta, UWORD32 u4_bs, const UWORD8 *pu1_cliptab) argument
652 ih264_deblk_chroma_vert_bslt4_bp(UWORD8 *pu1_src, WORD32 src_strd, WORD32 alpha, WORD32 beta, UWORD32 u4_bs, const UWORD8 *pu1_cliptab) argument
766 ih264_deblk_luma_horz_bslt4(UWORD8 *pu1_src, WORD32 src_strd, WORD32 alpha, WORD32 beta, UWORD32 u4_bs, const UWORD8 *pu1_cliptab) argument
885 ih264_deblk_chroma_horz_bslt4_bp(UWORD8 *pu1_src, WORD32 src_strd, WORD32 alpha, WORD32 beta, UWORD32 u4_bs, const UWORD8 *pu1_cliptab) argument
1009 ih264_deblk_luma_vert_bs4_mbaff(UWORD8 *pu1_src, WORD32 src_strd, WORD32 alpha, WORD32 beta) argument
1130 ih264_deblk_chroma_vert_bs4_mbaff_bp(UWORD8 *pu1_src, WORD32 src_strd, WORD32 alpha, WORD32 beta) argument
1219 ih264_deblk_luma_vert_bslt4_mbaff(UWORD8 *pu1_src, WORD32 src_strd, WORD32 alpha, WORD32 beta, UWORD32 u4_bs, const UWORD8 *pu1_cliptab) argument
1335 ih264_deblk_chroma_vert_bslt4_mbaff_bp(UWORD8 *pu1_src, WORD32 src_strd, WORD32 alpha, WORD32 beta, UWORD32 u4_bs, const UWORD8 *pu1_cliptab) argument
[all...]
/external/libpng/contrib/pngminus/
H A Dpnm2png.c53 BOOL pnm2png (FILE *pnm_file, FILE *png_file, FILE *alpha_file, BOOL interlace, BOOL alpha);
68 BOOL alpha = FALSE; local
81 alpha = TRUE;
86 fprintf (stderr, "Error: alpha-channel file %s does not exist\n",
144 if (pnm2png (fp_rd, fp_wr, fp_al, interlace, alpha) == FALSE)
155 /* close alpha file */
156 if (alpha)
179 fprintf (stderr, " -a[lpha] <file>.pgm read PNG alpha channel as pgm-file\n");
187 BOOL pnm2png (FILE *pnm_file, FILE *png_file, FILE *alpha_file, BOOL interlace, BOOL alpha) argument
298 /* read header of PGM file with alpha channe
[all...]
/external/mesa3d/src/gallium/drivers/softpipe/
H A Dsp_quad_blend.c291 const float *alpha = quadColor[3]; local
292 VEC4_MUL(source[0], quadColor[0], alpha); /* R */
293 VEC4_MUL(source[1], quadColor[1], alpha); /* G */
294 VEC4_MUL(source[2], quadColor[2], alpha); /* B */
304 const float *alpha = dest[3]; local
305 VEC4_MUL(source[0], quadColor[0], alpha); /* R */
306 VEC4_MUL(source[1], quadColor[1], alpha); /* G */
307 VEC4_MUL(source[2], quadColor[2], alpha); /* B */
312 const float *alpha = quadColor[3]; local
315 VEC4_MIN(temp, alpha, dif
334 float alpha[4]; local
348 const float *alpha = quadColor2[3]; local
457 const float *alpha = quadColor[3]; local
514 const float *alpha = quadColor2[3]; local
567 const float *alpha = quadColor[3]; local
1045 const float *alpha = quadColor[3]; local
[all...]
H A Dsp_quad_depth_test.c679 const float ref = qs->softpipe->depth_stencil->alpha.ref_value; \
680 const uint cbuf = 0; /* only output[0].alpha is tested */ \
718 switch (qs->softpipe->depth_stencil->alpha.func) {
778 if (qs->softpipe->depth_stencil->alpha.enabled) {
886 boolean alpha = qs->softpipe->depth_stencil->alpha.enabled; local
905 if (!alpha &&
911 else if (!alpha &&
/external/mesa3d/src/mesa/swrast/
H A Ds_renderbuffer.c487 GLboolean alpha,
482 _swrast_add_soft_renderbuffers(struct gl_framebuffer *fb, GLboolean color, GLboolean depth, GLboolean stencil, GLboolean accum, GLboolean alpha, GLboolean aux) argument
/external/opencv/cv/src/
H A Dcvoptflowhs.cpp52 float alpha; /* alpha = 1 / ( 1/lambda + xx + yy ) */ member in struct:__anon12928
266 II[address].alpha = 1 / (Ilambda + II[address].xx + II[address].yy);
289 II[address].alpha = 1 / (Ilambda + II[address].xx + II[address].yy);
313 II[address].alpha = 1 / (Ilambda + II[address].xx + II[address].yy);
371 II[address].xy * averageY + II[address].xt) * II[address].alpha;
375 II[address].yy * averageY + II[address].yt) * II[address].alpha;
398 II[address].xy * averageY + II[address].xt) * II[address].alpha;
402 II[address].yy * averageY + II[address].yt) * II[address].alpha;
427 II[address].xy * averageY + II[address].xt) * II[address].alpha;
[all...]
H A Dcvsnakes.cpp58 // alpha - pointer to coefficient of continuity energy,
61 // coeffUsage - if CV_VALUE - alpha, beta, gamma point to single value
76 float *alpha,
129 if( alpha == NULL )
349 _alpha = *alpha;
355 _alpha = alpha[i];
410 int length, float *alpha,
433 alpha, beta, gamma, coeffUsage, win, criteria,
71 icvSnake8uC1R( unsigned char *src, int srcStep, CvSize roi, CvPoint * pt, int n, float *alpha, float *beta, float *gamma, int coeffUsage, CvSize win, CvTermCriteria criteria, int scheme ) argument
409 cvSnakeImage( const IplImage* src, CvPoint* points, int length, float *alpha, float *beta, float *gamma, int coeffUsage, CvSize win, CvTermCriteria criteria, int calcGradient ) argument
/external/opencv/cvaux/src/
H A Dcvbgfg_acmmm2003.cpp499 float alpha = stat->is_trained_dyn_model ? model->params.alpha2 : model->params.alpha3; local
504 stat->Pbcc *= (1.f-alpha);
507 stat->Pbcc += alpha;
514 PV_CC(k) *= (1-alpha);
515 PVB_CC(k) *= (1-alpha);
544 PV_CC(indx) = alpha;
545 PVB_CC(indx) = alpha;
555 PV_CC(indx) += alpha;
558 PVB_CC(indx) += alpha;
607 float alpha local
[all...]
/external/pdfium/core/src/fpdfapi/fpdf_edit/
H A Dfpdf_edit_image.cpp278 FX_FLOAT alpha = src_buf[src_offset + 3] / 255.0f; local
279 dst_buf[src_offset] = (FX_BYTE)(src_buf[src_offset] * alpha);
280 dst_buf[src_offset + 1] = (FX_BYTE)(src_buf[src_offset + 1] * alpha);
281 dst_buf[src_offset + 2] = (FX_BYTE)(src_buf[src_offset + 2] * alpha);
326 FX_FLOAT alpha = bUseMatte ? src_buf[src_offset + 3] / 255.0f : 1; local
327 pDest[dest_offset] = (FX_BYTE)(src_buf[src_offset + 2] * alpha);
328 pDest[dest_offset + 1] = (FX_BYTE)(src_buf[src_offset + 1] * alpha);
329 pDest[dest_offset + 2] = (FX_BYTE)(src_buf[src_offset] * alpha);
/external/pdfium/samples/
H A Dimage_diff.cc310 uint32_t alpha = base_pixel & RGBA_ALPHA; local
311 uint32_t new_pixel = base_pixel - ((alpha / 2) & RGBA_ALPHA);

Completed in 654 milliseconds

<<11121314151617