Y                1536 libavcodec/aacsbr_template.c                 sbr->c.sbr_hf_assemble(sbr->data[ch].Y[sbr->data[ch].Ypos],
Y                1545 libavcodec/aacsbr_template.c                   (const INTFLOAT (*)[64][2]) sbr->data[ch].Y[1-sbr->data[ch].Ypos],
Y                1546 libavcodec/aacsbr_template.c                   (const INTFLOAT (*)[64][2]) sbr->data[ch].Y[  sbr->data[ch].Ypos],
Y                  31 libavcodec/aarch64/sbrdsp_init_aarch64.c void ff_sbr_hf_g_filt_neon(float (*Y)[2], const float (*X_high)[40][2],
Y                  37 libavcodec/aarch64/sbrdsp_init_aarch64.c void ff_sbr_hf_apply_noise_0_neon(float Y[64][2], const float *s_m,
Y                  40 libavcodec/aarch64/sbrdsp_init_aarch64.c void ff_sbr_hf_apply_noise_1_neon(float Y[64][2], const float *s_m,
Y                  43 libavcodec/aarch64/sbrdsp_init_aarch64.c void ff_sbr_hf_apply_noise_2_neon(float Y[64][2], const float *s_m,
Y                  46 libavcodec/aarch64/sbrdsp_init_aarch64.c void ff_sbr_hf_apply_noise_3_neon(float Y[64][2], const float *s_m,
Y                 316 libavcodec/aic.c     uint8_t *Y, *C[2];
Y                 332 libavcodec/aic.c     Y = ctx->frame->data[0] + mb_x * 16 + y_pos * ystride;
Y                 358 libavcodec/aic.c                 dst = Y + (blk >> 1) * 8 * ystride + (blk & 1) * 8;
Y                 361 libavcodec/aic.c                 dst = Y + (blk & 1) * 8 + (blk >> 1) * ystride;
Y                 366 libavcodec/aic.c         Y += 16;
Y                 986 libavcodec/apedec.c         int X = *decoded0, Y = *decoded1;
Y                 988 libavcodec/apedec.c             *decoded0 = filter_fast_3320(p, Y, 0, YDELAYA);
Y                 993 libavcodec/apedec.c             *decoded0 = filter_3800(p, Y, 0, YDELAYA, YDELAYB,
Y                1099 libavcodec/apedec.c         int Y = *decoded1, X = *decoded0;
Y                1100 libavcodec/apedec.c         *decoded0 = predictor_update_3930(p, Y, 0, YDELAYA);
Y                  33 libavcodec/arm/sbrdsp_init_arm.c void ff_sbr_hf_g_filt_neon(float (*Y)[2], const float (*X_high)[40][2],
Y                  40 libavcodec/arm/sbrdsp_init_arm.c void ff_sbr_hf_apply_noise_0_neon(float Y[64][2], const float *s_m,
Y                  43 libavcodec/arm/sbrdsp_init_arm.c void ff_sbr_hf_apply_noise_1_neon(float Y[64][2], const float *s_m,
Y                  46 libavcodec/arm/sbrdsp_init_arm.c void ff_sbr_hf_apply_noise_2_neon(float Y[64][2], const float *s_m,
Y                  49 libavcodec/arm/sbrdsp_init_arm.c void ff_sbr_hf_apply_noise_3_neon(float Y[64][2], const float *s_m,
Y                  38 libavcodec/arm/vc1dsp_init_neon.c #define DECL_PUT(X, Y) \
Y                  39 libavcodec/arm/vc1dsp_init_neon.c void ff_put_vc1_mspel_mc##X##Y##_neon(uint8_t *dst, const uint8_t *src, \
Y                  41 libavcodec/arm/vc1dsp_init_neon.c static void ff_put_vc1_mspel_mc##X##Y##_16_neon(uint8_t *dst, const uint8_t *src, \
Y                  44 libavcodec/arm/vc1dsp_init_neon.c   ff_put_vc1_mspel_mc##X##Y##_neon(dst+0, src+0, stride, rnd); \
Y                  45 libavcodec/arm/vc1dsp_init_neon.c   ff_put_vc1_mspel_mc##X##Y##_neon(dst+8, src+8, stride, rnd); \
Y                  47 libavcodec/arm/vc1dsp_init_neon.c   ff_put_vc1_mspel_mc##X##Y##_neon(dst+0, src+0, stride, rnd); \
Y                  48 libavcodec/arm/vc1dsp_init_neon.c   ff_put_vc1_mspel_mc##X##Y##_neon(dst+8, src+8, stride, rnd); \
Y                  80 libavcodec/arm/vc1dsp_init_neon.c #define FN_ASSIGN(X, Y) \
Y                  81 libavcodec/arm/vc1dsp_init_neon.c     dsp->put_vc1_mspel_pixels_tab[0][X+4*Y] = ff_put_vc1_mspel_mc##X##Y##_16_neon; \
Y                  82 libavcodec/arm/vc1dsp_init_neon.c     dsp->put_vc1_mspel_pixels_tab[1][X+4*Y] = ff_put_vc1_mspel_mc##X##Y##_neon
Y                  45 libavcodec/aura.c     uint8_t *Y, *U, *V;
Y                  65 libavcodec/aura.c     Y = frame->data[0];
Y                  74 libavcodec/aura.c         Y[0] = val << 4;
Y                  77 libavcodec/aura.c         Y[1] = Y[0] + delta_table[val & 0xF];
Y                  78 libavcodec/aura.c         Y   += 2; U++; V++;
Y                  84 libavcodec/aura.c             Y[0] = Y[-1] + delta_table[val & 0xF];
Y                  87 libavcodec/aura.c             Y[1] = Y[ 0] + delta_table[val & 0xF];
Y                  88 libavcodec/aura.c             Y   += 2; U++; V++;
Y                  90 libavcodec/aura.c         Y += frame->linesize[0] -  avctx->width;
Y                  36 libavcodec/binkdsp.c #define MUL(X,Y) ((int)((unsigned)(X) * (Y)) >> 11)
Y                  56 libavcodec/cbs_jpeg.h     uint16_t Y;
Y                  29 libavcodec/cbs_jpeg_syntax_template.c     u(16, Y,  0, JPEG_MAX_HEIGHT);
Y                 146 libavcodec/dxtory.c     uint8_t *Y, *U, *V;
Y                 158 libavcodec/dxtory.c     Y = pic->data[0];
Y                 163 libavcodec/dxtory.c             Y[w] = *src++;
Y                 167 libavcodec/dxtory.c         Y += pic->linesize[0];
Y                 446 libavcodec/dxtory.c     uint8_t *Y  = frame->data[0] + ystride * line;
Y                 454 libavcodec/dxtory.c                     Y[x + i + j * ystride] = decode_sym(gb, lru[0]);
Y                 459 libavcodec/dxtory.c         Y += ystride << 2;
Y                 489 libavcodec/dxtory.c     uint8_t *Y  = frame->data[0] + ystride * line;
Y                 496 libavcodec/dxtory.c             Y[x + 0 + 0 * ystride] = decode_sym(gb, lru[0]);
Y                 497 libavcodec/dxtory.c             Y[x + 1 + 0 * ystride] = decode_sym(gb, lru[0]);
Y                 498 libavcodec/dxtory.c             Y[x + 0 + 1 * ystride] = decode_sym(gb, lru[0]);
Y                 499 libavcodec/dxtory.c             Y[x + 1 + 1 * ystride] = decode_sym(gb, lru[0]);
Y                 504 libavcodec/dxtory.c         Y += ystride << 1;
Y                 533 libavcodec/dxtory.c     uint8_t *Y  = frame->data[0] + ystride * line;
Y                 539 libavcodec/dxtory.c             Y[x] = decode_sym(gb, lru[0]);
Y                 544 libavcodec/dxtory.c         Y += ystride;
Y                 280 libavcodec/g2meet.c static inline void yuv2rgb(uint8_t *out, int ridx, int Y, int U, int V)
Y                 282 libavcodec/g2meet.c     out[ridx]     = av_clip_uint8(Y +              (91881 * V + 32768 >> 16));
Y                 283 libavcodec/g2meet.c     out[1]        = av_clip_uint8(Y + (-22554 * U - 46802 * V + 32768 >> 16));
Y                 284 libavcodec/g2meet.c     out[2 - ridx] = av_clip_uint8(Y + (116130 * U             + 32768 >> 16));
Y                 348 libavcodec/g2meet.c                     int Y, U, V;
Y                 350 libavcodec/g2meet.c                     Y = c->block[(j >> 3) * 2 + (i >> 3)][(i & 7) + (j & 7) * 8];
Y                 353 libavcodec/g2meet.c                     yuv2rgb(out + i * 3, ridx, Y, U, V);
Y                 666 libavcodec/mips/sbrdsp_mips.c static void sbr_hf_g_filt_mips(float (*Y)[2], const float (*X_high)[40][2],
Y                 674 libavcodec/mips/sbrdsp_mips.c     p_y = &Y[0][0];
Y                 703 libavcodec/mips/sbrdsp_mips.c static void sbr_hf_apply_noise_0_mips(float (*Y)[2], const float *s_m,
Y                 711 libavcodec/mips/sbrdsp_mips.c         float *Y1=&Y[m][0];
Y                 748 libavcodec/mips/sbrdsp_mips.c static void sbr_hf_apply_noise_1_mips(float (*Y)[2], const float *s_m,
Y                 759 libavcodec/mips/sbrdsp_mips.c         float *Y1=&Y[m][0];
Y                 795 libavcodec/mips/sbrdsp_mips.c static void sbr_hf_apply_noise_2_mips(float (*Y)[2], const float *s_m,
Y                 805 libavcodec/mips/sbrdsp_mips.c         float *Y1=&Y[m][0];
Y                 839 libavcodec/mips/sbrdsp_mips.c static void sbr_hf_apply_noise_3_mips(float (*Y)[2], const float *s_m,
Y                 848 libavcodec/mips/sbrdsp_mips.c         float *Y1=&Y[m][0];
Y                  26 libavcodec/mips/vc1dsp_init_mips.c #define FN_ASSIGN(OP, X, Y, INSN) \
Y                  27 libavcodec/mips/vc1dsp_init_mips.c     dsp->OP##vc1_mspel_pixels_tab[1][X+4*Y] = ff_##OP##vc1_mspel_mc##X##Y##INSN; \
Y                  28 libavcodec/mips/vc1dsp_init_mips.c     dsp->OP##vc1_mspel_pixels_tab[0][X+4*Y] = ff_##OP##vc1_mspel_mc##X##Y##_16##INSN
Y                 464 libavcodec/opus.c         float *Y = (f->channels == 2) ? f->block[1].coeffs + band_offset : NULL;
Y                 532 libavcodec/opus.c             cm[1] = f->pvq->quant_band(f->pvq, f, rc, i, Y, NULL, band_size, b >> 1,
Y                 537 libavcodec/opus.c             cm[0] = f->pvq->quant_band(f->pvq, f, rc, i, X,    Y, band_size, b >> 0,
Y                 161 libavcodec/opus_pvq.c static inline void celt_stereo_merge(float *X, float *Y, float mid, int N)
Y                 171 libavcodec/opus_pvq.c         xp   += X[i] * Y[i];
Y                 172 libavcodec/opus_pvq.c         side += Y[i] * Y[i];
Y                 182 libavcodec/opus_pvq.c             Y[i] = X[i];
Y                 193 libavcodec/opus_pvq.c         value[1] = Y[i];
Y                 195 libavcodec/opus_pvq.c         Y[i] = gain[1] * (value[0] + value[1]);
Y                 443 libavcodec/opus_pvq.c static int celt_calc_theta(const float *X, const float *Y, int coupling, int N)
Y                 449 libavcodec/opus_pvq.c             e[0] += (X[i] + Y[i])*(X[i] + Y[i]);
Y                 450 libavcodec/opus_pvq.c             e[1] += (X[i] - Y[i])*(X[i] - Y[i]);
Y                 455 libavcodec/opus_pvq.c             e[1] += Y[i]*Y[i];
Y                 461 libavcodec/opus_pvq.c static void celt_stereo_is_decouple(float *X, float *Y, float e_l, float e_r, int N)
Y                 468 libavcodec/opus_pvq.c         X[i] = e_l*X[i] + e_r*Y[i];
Y                 471 libavcodec/opus_pvq.c static void celt_stereo_ms_decouple(float *X, float *Y, int N)
Y                 476 libavcodec/opus_pvq.c         X[i] = (X[i] + Y[i])*M_SQRT1_2;
Y                 477 libavcodec/opus_pvq.c         Y[i] = (Y[i] - Xret)*M_SQRT1_2;
Y                 484 libavcodec/opus_pvq.c                                                      float *Y, int N, int b,
Y                 493 libavcodec/opus_pvq.c     int stereo = !!Y, split = stereo;
Y                 520 libavcodec/opus_pvq.c             x = Y;
Y                 574 libavcodec/opus_pvq.c         Y = X + N;
Y                 584 libavcodec/opus_pvq.c         int itheta = quant ? celt_calc_theta(X, Y, stereo, N) : 0;
Y                 614 libavcodec/opus_pvq.c                         celt_stereo_is_decouple(X, Y, f->block[0].lin_energy[band],
Y                 617 libavcodec/opus_pvq.c                         celt_stereo_ms_decouple(X, Y, N);
Y                 633 libavcodec/opus_pvq.c                        Y[i] *= -1;
Y                 635 libavcodec/opus_pvq.c                  celt_stereo_is_decouple(X, Y, f->block[0].lin_energy[band],
Y                 689 libavcodec/opus_pvq.c             x2 = c ? Y : X;
Y                 690 libavcodec/opus_pvq.c             y2 = c ? X : Y;
Y                 710 libavcodec/opus_pvq.c             Y[0] *= side;
Y                 711 libavcodec/opus_pvq.c             Y[1] *= side;
Y                 713 libavcodec/opus_pvq.c             X[0] = tmp - Y[0];
Y                 714 libavcodec/opus_pvq.c             Y[0] = tmp + Y[0];
Y                 716 libavcodec/opus_pvq.c             X[1] = tmp - Y[1];
Y                 717 libavcodec/opus_pvq.c             Y[1] = tmp + Y[1];
Y                 764 libavcodec/opus_pvq.c                 cmt = pvq->quant_band(pvq, f, rc, band, Y, NULL, N, sbits, blocks,
Y                 771 libavcodec/opus_pvq.c                 cm = pvq->quant_band(pvq, f, rc, band, Y, NULL, N, sbits, blocks,
Y                 836 libavcodec/opus_pvq.c             celt_stereo_merge(X, Y, mid, N);
Y                 839 libavcodec/opus_pvq.c                 Y[i] *= -1;
Y                 880 libavcodec/opus_pvq.c     return quant_band_template(pvq, f, rc, band, X, Y, N, b, blocks, lowband, duration,
Y                 890 libavcodec/opus_pvq.c     return quant_band_template(pvq, f, rc, band, X, Y, N, b, blocks, lowband, duration,
Y                  30 libavcodec/opus_pvq.h                                        float *Y, int N, int b, uint32_t blocks,      \
Y                  38 libavcodec/opusenc_psy.c     float *Y = (f->channels == 2) ? &buf[176] : NULL;
Y                  43 libavcodec/opusenc_psy.c     if (Y)
Y                  44 libavcodec/opusenc_psy.c         memcpy(Y, Y_orig, band_size*sizeof(float));
Y                  56 libavcodec/opusenc_psy.c         pvq->quant_band(pvq, f, rc, band, Y, NULL, band_size, b / 2, f->blocks, NULL,
Y                  59 libavcodec/opusenc_psy.c         pvq->quant_band(pvq, f, rc, band, X, Y, band_size, b, f->blocks, NULL, f->size,
Y                  65 libavcodec/opusenc_psy.c         if (Y)
Y                  66 libavcodec/opusenc_psy.c             err_y += (Y[i] - Y_orig[i])*(Y[i] - Y_orig[i]);
Y                 658 libavcodec/qsv.c     ptr->Y     = qsv_mid->locked_frame->data[0];
Y                 314 libavcodec/qsvdec.c         frame->surface.Data.Y        = frame->frame->data[0];
Y                1370 libavcodec/qsvenc.c         qf->surface.Data.Y         = qf->frame->data[0];
Y                 156 libavcodec/rv30.c     uint8_t *Y, *C;
Y                 177 libavcodec/rv30.c             Y = s->current_picture_ptr->f->data[0] + mb_x*16 + (row*16 + j) * s->linesize + 4 * !mb_x;
Y                 178 libavcodec/rv30.c             for(i = !mb_x; i < 4; i++, Y += 4){
Y                 188 libavcodec/rv30.c                     rv30_weak_loop_filter(Y, 1, s->linesize, loc_lim);
Y                 219 libavcodec/rv30.c             Y = s->current_picture_ptr->f->data[0] + mb_x*16 + (row*16 + j) * s->linesize;
Y                 220 libavcodec/rv30.c             for(i = 0; i < 4; i++, Y += 4){
Y                 230 libavcodec/rv30.c                     rv30_weak_loop_filter(Y, s->linesize, 1, loc_lim);
Y                 673 libavcodec/rv34.c     uint8_t *Y, *U, *V, *srcY, *srcU, *srcV;
Y                 739 libavcodec/rv34.c         Y = s->dest[0] + xoff      + yoff     *s->linesize;
Y                 743 libavcodec/rv34.c         Y = r->tmp_b_block_y [dir]     +  xoff     +  yoff    *s->linesize;
Y                 749 libavcodec/rv34.c         qpel_mc[1][dxy](Y, srcY, s->linesize);
Y                 750 libavcodec/rv34.c         Y    += 8;
Y                 753 libavcodec/rv34.c         qpel_mc[1][dxy](Y, srcY, s->linesize);
Y                 754 libavcodec/rv34.c         Y    += 8 * s->linesize;
Y                 758 libavcodec/rv34.c     qpel_mc[!is16x16][dxy](Y, srcY, s->linesize);
Y                 342 libavcodec/rv40.c     uint8_t *Y, *C;
Y                 462 libavcodec/rv40.c             Y = s->current_picture_ptr->f->data[0] + mb_x*16 + (row*16 + j) * s->linesize;
Y                 463 libavcodec/rv40.c             for(i = 0; i < 4; i++, Y += 4){
Y                 471 libavcodec/rv40.c                     rv40_adaptive_loop_filter(&r->rdsp, Y+4*s->linesize,
Y                 483 libavcodec/rv40.c                     rv40_adaptive_loop_filter(&r->rdsp, Y, s->linesize, dither,
Y                 490 libavcodec/rv40.c                     rv40_adaptive_loop_filter(&r->rdsp, Y, s->linesize, dither,
Y                 498 libavcodec/rv40.c                     rv40_adaptive_loop_filter(&r->rdsp, Y, s->linesize, dither,
Y                  94 libavcodec/sbr.h     DECLARE_ALIGNED(16, INTFLOAT, Y)[2][38][64][2];
Y                 187 libavcodec/sbrdsp.c static void sbr_hf_g_filt_c(float (*Y)[2], const float (*X_high)[40][2],
Y                 193 libavcodec/sbrdsp.c         Y[m][0] = X_high[m][ixh][0] * g_filt[m];
Y                 194 libavcodec/sbrdsp.c         Y[m][1] = X_high[m][ixh][1] * g_filt[m];
Y                 198 libavcodec/sbrdsp.c static av_always_inline void sbr_hf_apply_noise(float (*Y)[2],
Y                 209 libavcodec/sbrdsp.c         float y0 = Y[m][0];
Y                 210 libavcodec/sbrdsp.c         float y1 = Y[m][1];
Y                 219 libavcodec/sbrdsp.c         Y[m][0] = y0;
Y                 220 libavcodec/sbrdsp.c         Y[m][1] = y1;
Y                  40 libavcodec/sbrdsp.h     void (*hf_g_filt)(INTFLOAT (*Y)[2], const INTFLOAT (*X_high)[40][2],
Y                  42 libavcodec/sbrdsp.h     void (*hf_apply_noise[4])(INTFLOAT (*Y)[2], const AAC_FLOAT *s_m,
Y                 244 libavcodec/sbrdsp_fixed.c static void sbr_hf_g_filt_c(int (*Y)[2], const int (*X_high)[40][2],
Y                 254 libavcodec/sbrdsp_fixed.c             Y[m][0] = (int)((accu + r) >> (23-g_filt[m].exp));
Y                 257 libavcodec/sbrdsp_fixed.c             Y[m][1] = (int)((accu + r) >> (23-g_filt[m].exp));
Y                 262 libavcodec/sbrdsp_fixed.c static av_always_inline int sbr_hf_apply_noise(int (*Y)[2],
Y                 273 libavcodec/sbrdsp_fixed.c         unsigned y0 = Y[m][0];
Y                 274 libavcodec/sbrdsp_fixed.c         unsigned y1 = Y[m][1];
Y                 308 libavcodec/sbrdsp_fixed.c         Y[m][0] = y0;
Y                 309 libavcodec/sbrdsp_fixed.c         Y[m][1] = y1;
Y                  46 libavcodec/sbrdsp_template.c static void sbr_hf_apply_noise_0(INTFLOAT (*Y)[2], const AAC_FLOAT *s_m,
Y                  50 libavcodec/sbrdsp_template.c     sbr_hf_apply_noise(Y, s_m, q_filt, noise, (INTFLOAT)1.0, (INTFLOAT)0.0, m_max);
Y                  53 libavcodec/sbrdsp_template.c static void sbr_hf_apply_noise_1(INTFLOAT (*Y)[2], const AAC_FLOAT *s_m,
Y                  58 libavcodec/sbrdsp_template.c     sbr_hf_apply_noise(Y, s_m, q_filt, noise, (INTFLOAT)0.0, phi_sign, m_max);
Y                  61 libavcodec/sbrdsp_template.c static void sbr_hf_apply_noise_2(INTFLOAT (*Y)[2], const AAC_FLOAT *s_m,
Y                  65 libavcodec/sbrdsp_template.c     sbr_hf_apply_noise(Y, s_m, q_filt, noise, (INTFLOAT)-1.0, (INTFLOAT)0.0, m_max);
Y                  68 libavcodec/sbrdsp_template.c static void sbr_hf_apply_noise_3(INTFLOAT (*Y)[2], const AAC_FLOAT *s_m,
Y                  73 libavcodec/sbrdsp_template.c     sbr_hf_apply_noise(Y, s_m, q_filt, noise, (INTFLOAT)0.0, -phi_sign, m_max);
Y                 314 libavcodec/tdsc.c static inline void tdsc_yuv2rgb(uint8_t *out, int Y, int U, int V)
Y                 316 libavcodec/tdsc.c     out[0] = av_clip_uint8(Y + (             91881 * V + 32768 >> 16));
Y                 317 libavcodec/tdsc.c     out[1] = av_clip_uint8(Y + (-22554 * U - 46802 * V + 32768 >> 16));
Y                 318 libavcodec/tdsc.c     out[2] = av_clip_uint8(Y + (116130 * U             + 32768 >> 16));
Y                 433 libavcodec/truemotion2.c     int *Y, *U, *V;\
Y                 439 libavcodec/truemotion2.c     Y = (ctx->cur?ctx->Y2:ctx->Y1) + by * 4 * Ystride + bx * 4;\
Y                 465 libavcodec/truemotion2.c static inline void tm2_apply_deltas(TM2Context *ctx, int* Y, int stride, int *deltas, int *last)
Y                 476 libavcodec/truemotion2.c             Y[i]     = av_clip_uint8(last[i]);
Y                 478 libavcodec/truemotion2.c         Y        += stride;
Y                 533 libavcodec/truemotion2.c     tm2_apply_deltas(ctx, Y, Ystride, deltas, last);
Y                 555 libavcodec/truemotion2.c     tm2_apply_deltas(ctx, Y, Ystride, deltas, last);
Y                 596 libavcodec/truemotion2.c     tm2_apply_deltas(ctx, Y, Ystride, deltas, last);
Y                 643 libavcodec/truemotion2.c     tm2_apply_deltas(ctx, Y, Ystride, deltas, last);
Y                 673 libavcodec/truemotion2.c             Y[i]    = Yo[i];
Y                 676 libavcodec/truemotion2.c         Y  += Ystride;
Y                 712 libavcodec/truemotion2.c             Y[i]    = Yo[i] + (unsigned)GET_TOK(ctx, TM2_UPD);
Y                 713 libavcodec/truemotion2.c             last[i] = Y[i];
Y                 716 libavcodec/truemotion2.c         Y  += Ystride;
Y                 760 libavcodec/truemotion2.c             Y[i] = Yo[i];
Y                 762 libavcodec/truemotion2.c         Y  += Ystride;
Y                 766 libavcodec/truemotion2.c     Y -= Ystride * 4;
Y                 767 libavcodec/truemotion2.c     ctx->D[0] = (unsigned)Y[3] - last[3];
Y                 768 libavcodec/truemotion2.c     ctx->D[1] = (unsigned)Y[3 + Ystride] - Y[3];
Y                 769 libavcodec/truemotion2.c     ctx->D[2] = (unsigned)Y[3 + Ystride * 2] - Y[3 + Ystride];
Y                 770 libavcodec/truemotion2.c     ctx->D[3] = (unsigned)Y[3 + Ystride * 3] - Y[3 + Ystride * 2];
Y                 772 libavcodec/truemotion2.c         last[i] = Y[i + Ystride * 3];
Y                 781 libavcodec/truemotion2.c     int *Y, *U, *V;
Y                 834 libavcodec/truemotion2.c     Y = (ctx->cur?ctx->Y2:ctx->Y1);
Y                 840 libavcodec/truemotion2.c             unsigned y = Y[i], u = U[i >> 1], v = V[i >> 1];
Y                 847 libavcodec/truemotion2.c         Y[-4]    = Y[-3]    = Y[-2]    = Y[-1] = Y[0];
Y                 848 libavcodec/truemotion2.c         Y[w + 3] = Y[w + 2] = Y[w + 1] = Y[w]  = Y[w - 1];
Y                 852 libavcodec/truemotion2.c             memcpy(Y - 4 - 1 * ctx->y_stride, Y - 4, ctx->y_stride);
Y                 853 libavcodec/truemotion2.c             memcpy(Y - 4 - 2 * ctx->y_stride, Y - 4, ctx->y_stride);
Y                 854 libavcodec/truemotion2.c             memcpy(Y - 4 - 3 * ctx->y_stride, Y - 4, ctx->y_stride);
Y                 855 libavcodec/truemotion2.c             memcpy(Y - 4 - 4 * ctx->y_stride, Y - 4, ctx->y_stride);
Y                 857 libavcodec/truemotion2.c             memcpy(Y - 4 + 1 * ctx->y_stride, Y - 4, ctx->y_stride);
Y                 858 libavcodec/truemotion2.c             memcpy(Y - 4 + 2 * ctx->y_stride, Y - 4, ctx->y_stride);
Y                 859 libavcodec/truemotion2.c             memcpy(Y - 4 + 3 * ctx->y_stride, Y - 4, ctx->y_stride);
Y                 860 libavcodec/truemotion2.c             memcpy(Y - 4 + 4 * ctx->y_stride, Y - 4, ctx->y_stride);
Y                 863 libavcodec/truemotion2.c         Y += ctx->y_stride;
Y                 143 libavcodec/ulti.c static void ulti_grad(AVFrame *frame, int x, int y, uint8_t *Y, int chroma, int angle)
Y                 149 libavcodec/ulti.c         t = Y[0];
Y                 150 libavcodec/ulti.c         Y[0] = Y[3];
Y                 151 libavcodec/ulti.c         Y[3] = t;
Y                 152 libavcodec/ulti.c         t = Y[1];
Y                 153 libavcodec/ulti.c         Y[1] = Y[2];
Y                 154 libavcodec/ulti.c         Y[2] = t;
Y                 158 libavcodec/ulti.c         Luma[0]  = Y[0]; Luma[1]  = Y[1]; Luma[2]  = Y[2]; Luma[3]  = Y[3];
Y                 159 libavcodec/ulti.c         Luma[4]  = Y[0]; Luma[5]  = Y[1]; Luma[6]  = Y[2]; Luma[7]  = Y[3];
Y                 160 libavcodec/ulti.c         Luma[8]  = Y[0]; Luma[9]  = Y[1]; Luma[10] = Y[2]; Luma[11] = Y[3];
Y                 161 libavcodec/ulti.c         Luma[12] = Y[0]; Luma[13] = Y[1]; Luma[14] = Y[2]; Luma[15] = Y[3];
Y                 164 libavcodec/ulti.c         Luma[0]  = Y[1]; Luma[1]  = Y[2]; Luma[2]  = Y[3]; Luma[3]  = Y[3];
Y                 165 libavcodec/ulti.c         Luma[4]  = Y[0]; Luma[5]  = Y[1]; Luma[6]  = Y[2]; Luma[7]  = Y[3];
Y                 166 libavcodec/ulti.c         Luma[8]  = Y[0]; Luma[9]  = Y[1]; Luma[10] = Y[2]; Luma[11] = Y[3];
Y                 167 libavcodec/ulti.c         Luma[12] = Y[0]; Luma[13] = Y[0]; Luma[14] = Y[1]; Luma[15] = Y[2];
Y                 170 libavcodec/ulti.c         Luma[0]  = Y[1]; Luma[1]  = Y[2]; Luma[2]  = Y[3]; Luma[3]  = Y[3];
Y                 171 libavcodec/ulti.c         Luma[4]  = Y[1]; Luma[5]  = Y[2]; Luma[6]  = Y[2]; Luma[7]  = Y[3];
Y                 172 libavcodec/ulti.c         Luma[8]  = Y[0]; Luma[9]  = Y[1]; Luma[10] = Y[1]; Luma[11] = Y[2];
Y                 173 libavcodec/ulti.c         Luma[12] = Y[0]; Luma[13] = Y[0]; Luma[14] = Y[1]; Luma[15] = Y[2];
Y                 176 libavcodec/ulti.c         Luma[0]  = Y[2]; Luma[1]  = Y[3]; Luma[2]  = Y[3]; Luma[3]  = Y[3];
Y                 177 libavcodec/ulti.c         Luma[4]  = Y[1]; Luma[5]  = Y[2]; Luma[6]  = Y[2]; Luma[7]  = Y[3];
Y                 178 libavcodec/ulti.c         Luma[8]  = Y[0]; Luma[9]  = Y[1]; Luma[10] = Y[1]; Luma[11] = Y[2];
Y                 179 libavcodec/ulti.c         Luma[12] = Y[0]; Luma[13] = Y[0]; Luma[14] = Y[0]; Luma[15] = Y[1];
Y                 182 libavcodec/ulti.c         Luma[0]  = Y[3]; Luma[1]  = Y[3]; Luma[2]  = Y[3]; Luma[3]  = Y[3];
Y                 183 libavcodec/ulti.c         Luma[4]  = Y[2]; Luma[5]  = Y[2]; Luma[6]  = Y[2]; Luma[7]  = Y[2];
Y                 184 libavcodec/ulti.c         Luma[8]  = Y[1]; Luma[9]  = Y[1]; Luma[10] = Y[1]; Luma[11] = Y[1];
Y                 185 libavcodec/ulti.c         Luma[12] = Y[0]; Luma[13] = Y[0]; Luma[14] = Y[0]; Luma[15] = Y[0];
Y                 188 libavcodec/ulti.c         Luma[0]  = Y[3]; Luma[1]  = Y[3]; Luma[2]  = Y[3]; Luma[3]  = Y[2];
Y                 189 libavcodec/ulti.c         Luma[4]  = Y[3]; Luma[5]  = Y[2]; Luma[6]  = Y[2]; Luma[7]  = Y[1];
Y                 190 libavcodec/ulti.c         Luma[8]  = Y[2]; Luma[9]  = Y[1]; Luma[10] = Y[1]; Luma[11] = Y[0];
Y                 191 libavcodec/ulti.c         Luma[12] = Y[1]; Luma[13] = Y[0]; Luma[14] = Y[0]; Luma[15] = Y[0];
Y                 194 libavcodec/ulti.c         Luma[0]  = Y[3]; Luma[1]  = Y[3]; Luma[2]  = Y[2]; Luma[3]  = Y[2];
Y                 195 libavcodec/ulti.c         Luma[4]  = Y[3]; Luma[5]  = Y[2]; Luma[6]  = Y[1]; Luma[7]  = Y[1];
Y                 196 libavcodec/ulti.c         Luma[8]  = Y[2]; Luma[9]  = Y[2]; Luma[10] = Y[1]; Luma[11] = Y[0];
Y                 197 libavcodec/ulti.c         Luma[12] = Y[1]; Luma[13] = Y[1]; Luma[14] = Y[0]; Luma[15] = Y[0];
Y                 200 libavcodec/ulti.c         Luma[0]  = Y[3]; Luma[1]  = Y[3]; Luma[2]  = Y[2]; Luma[3]  = Y[1];
Y                 201 libavcodec/ulti.c         Luma[4]  = Y[3]; Luma[5]  = Y[2]; Luma[6]  = Y[1]; Luma[7]  = Y[0];
Y                 202 libavcodec/ulti.c         Luma[8]  = Y[3]; Luma[9]  = Y[2]; Luma[10] = Y[1]; Luma[11] = Y[0];
Y                 203 libavcodec/ulti.c         Luma[12] = Y[2]; Luma[13] = Y[1]; Luma[14] = Y[0]; Luma[15] = Y[0];
Y                 206 libavcodec/ulti.c         Luma[0]  = Y[0]; Luma[1]  = Y[0]; Luma[2]  = Y[1]; Luma[3]  = Y[1];
Y                 207 libavcodec/ulti.c         Luma[4]  = Y[0]; Luma[5]  = Y[0]; Luma[6]  = Y[1]; Luma[7]  = Y[1];
Y                 208 libavcodec/ulti.c         Luma[8]  = Y[2]; Luma[9]  = Y[2]; Luma[10] = Y[3]; Luma[11] = Y[3];
Y                 209 libavcodec/ulti.c         Luma[12] = Y[2]; Luma[13] = Y[2]; Luma[14] = Y[3]; Luma[15] = Y[3];
Y                 280 libavcodec/ulti.c             uint8_t Y[4]; // luma samples of block
Y                 308 libavcodec/ulti.c                     Y[0] = tmp & 0x3F;
Y                 309 libavcodec/ulti.c                     Y[1] = Y[0];
Y                 312 libavcodec/ulti.c                         Y[2] = Y[0]+1;
Y                 313 libavcodec/ulti.c                         if (Y[2] > 0x3F)
Y                 314 libavcodec/ulti.c                             Y[2] = 0x3F;
Y                 315 libavcodec/ulti.c                         Y[3] = Y[2];
Y                 317 libavcodec/ulti.c                         Y[2] = Y[0];
Y                 318 libavcodec/ulti.c                         Y[3] = Y[0];
Y                 326 libavcodec/ulti.c                         Y[0] = (tmp >> 18) & 0x3F;
Y                 327 libavcodec/ulti.c                         Y[1] = (tmp >> 12) & 0x3F;
Y                 328 libavcodec/ulti.c                         Y[2] = (tmp >> 6) & 0x3F;
Y                 329 libavcodec/ulti.c                         Y[3] = tmp & 0x3F;
Y                 337 libavcodec/ulti.c                         Y[0] = s->ulti_codebook[tmp];
Y                 338 libavcodec/ulti.c                         Y[1] = s->ulti_codebook[tmp + 1];
Y                 339 libavcodec/ulti.c                         Y[2] = s->ulti_codebook[tmp + 2];
Y                 340 libavcodec/ulti.c                         Y[3] = s->ulti_codebook[tmp + 3];
Y                 382 libavcodec/ulti.c                             Y[0] = (tmp >> 6) & 0x3F;
Y                 383 libavcodec/ulti.c                             Y[1] = tmp & 0x3F;
Y                 384 libavcodec/ulti.c                             Y[2] = bytestream2_get_byteu(&s->gb) & 0x3F;
Y                 385 libavcodec/ulti.c                             Y[3] = bytestream2_get_byteu(&s->gb) & 0x3F;
Y                 386 libavcodec/ulti.c                             ulti_grad(s->frame, tx, ty, Y, chroma, angle); //draw block
Y                 390 libavcodec/ulti.c                             Y[0] = bytestream2_get_byteu(&s->gb) & 0x3F;
Y                 391 libavcodec/ulti.c                             Y[1] = bytestream2_get_byteu(&s->gb) & 0x3F;
Y                 392 libavcodec/ulti.c                             ulti_pattern(s->frame, tx, ty, f0, f1, Y[0], Y[1], chroma);
Y                 398 libavcodec/ulti.c                     ulti_grad(s->frame, tx, ty, Y, chroma, angle); // draw block
Y                 247 libavcodec/vaapi_encode_mjpeg.c     fh->Y  = avctx->height;
Y                 384 libavcodec/vaapi_encode_mjpeg.c         .picture_height = fh->Y,
Y                 403 libavcodec/vc1_pred.c         int qx, qy, X, Y;
Y                 408 libavcodec/vc1_pred.c         Y  = (s->mb_height << 6) - 4;
Y                 412 libavcodec/vc1_pred.c         if (qy + py > Y) py = Y - qy;
Y                 768 libavcodec/vc1_pred.c             int qx, qy, X, Y;
Y                 774 libavcodec/vc1_pred.c             Y  = (s->mb_height << sh) - 4;
Y                 778 libavcodec/vc1_pred.c             if (qy + py > Y) py = Y - qy;
Y                 838 libavcodec/vc1_pred.c             int qx, qy, X, Y;
Y                 844 libavcodec/vc1_pred.c             Y  = (s->mb_height << sh) - 4;
Y                 848 libavcodec/vc1_pred.c             if (qy + py > Y) py = Y - qy;
Y                 965 libavcodec/vc1dsp.c #define FN_ASSIGN(X, Y) \
Y                 966 libavcodec/vc1dsp.c     dsp->put_vc1_mspel_pixels_tab[1][X+4*Y] = put_vc1_mspel_mc##X##Y##_c; \
Y                 967 libavcodec/vc1dsp.c     dsp->put_vc1_mspel_pixels_tab[0][X+4*Y] = put_vc1_mspel_mc##X##Y##_16_c; \
Y                 968 libavcodec/vc1dsp.c     dsp->avg_vc1_mspel_pixels_tab[1][X+4*Y] = avg_vc1_mspel_mc##X##Y##_c; \
Y                 969 libavcodec/vc1dsp.c     dsp->avg_vc1_mspel_pixels_tab[0][X+4*Y] = avg_vc1_mspel_mc##X##Y##_16_c
Y                  66 libavcodec/wnv1.c     unsigned char *Y,*U,*V;
Y                 113 libavcodec/wnv1.c     Y = p->data[0];
Y                 118 libavcodec/wnv1.c             Y[i * 2] = wnv1_get_code(l, prev_y);
Y                 120 libavcodec/wnv1.c             prev_y = Y[(i * 2) + 1] = wnv1_get_code(l, Y[i * 2]);
Y                 123 libavcodec/wnv1.c         Y += p->linesize[0];
Y                  30 libavcodec/x86/sbrdsp_init.c void ff_sbr_hf_g_filt_sse(float (*Y)[2], const float (*X_high)[40][2],
Y                  41 libavcodec/x86/sbrdsp_init.c void ff_sbr_hf_apply_noise_0_sse2(float (*Y)[2], const float *s_m,
Y                  44 libavcodec/x86/sbrdsp_init.c void ff_sbr_hf_apply_noise_1_sse2(float (*Y)[2], const float *s_m,
Y                  47 libavcodec/x86/sbrdsp_init.c void ff_sbr_hf_apply_noise_2_sse2(float (*Y)[2], const float *s_m,
Y                  50 libavcodec/x86/sbrdsp_init.c void ff_sbr_hf_apply_noise_3_sse2(float (*Y)[2], const float *s_m,
Y                 439 libavcodec/x86/vc1dsp_mmx.c #define FN_ASSIGN(OP, X, Y, INSN) \
Y                 440 libavcodec/x86/vc1dsp_mmx.c     dsp->OP##vc1_mspel_pixels_tab[1][X+4*Y] = OP##vc1_mspel_mc##X##Y##INSN; \
Y                 441 libavcodec/x86/vc1dsp_mmx.c     dsp->OP##vc1_mspel_pixels_tab[0][X+4*Y] = OP##vc1_mspel_mc##X##Y##_16##INSN
Y                  46 libavcodec/xl.c     uint8_t *Y, *U, *V;
Y                  66 libavcodec/xl.c     Y = p->data[0];
Y                 103 libavcodec/xl.c             Y[j + 0] = y0 << 1;
Y                 104 libavcodec/xl.c             Y[j + 1] = y1 << 1;
Y                 105 libavcodec/xl.c             Y[j + 2] = y2 << 1;
Y                 106 libavcodec/xl.c             Y[j + 3] = y3 << 1;
Y                 113 libavcodec/xl.c         Y   += p->linesize[0];
Y                 645 libavfilter/f_ebur128.c #define FILTER(Y, X, name) do {                                                 \
Y                 646 libavfilter/f_ebur128.c             double *dst = ebur128->Y + ch*3;                                    \
Y                 157 libavfilter/qsvvpp.c         surface->Data.Y  = frame->data[0];
Y                 161 libavfilter/qsvvpp.c         surface->Data.Y = frame->data[0];
Y                 166 libavfilter/qsvvpp.c         surface->Data.Y = frame->data[0];
Y                  70 libavfilter/vf_addroi.c         case Y: max_value = inlink->h;                  break;
Y                  72 libavfilter/vf_addroi.c         case H: max_value = inlink->h - ctx->region[Y]; break;
Y                 143 libavfilter/vf_addroi.c             .top       = ctx->region[Y],
Y                 144 libavfilter/vf_addroi.c             .bottom    = ctx->region[Y] + ctx->region[H],
Y                 171 libavfilter/vf_addroi.c             .top       = ctx->region[Y],
Y                 172 libavfilter/vf_addroi.c             .bottom    = ctx->region[Y] + ctx->region[H],
Y                 223 libavfilter/vf_addroi.c       OFFSET(region_str[Y]), AV_OPT_TYPE_STRING, { .str = "0" }, .flags = FLAGS },
Y                 132 libavfilter/vf_alphamerge.c         const int alpha_linesize = alpha_buf->linesize[Y];
Y                 134 libavfilter/vf_alphamerge.c                             alpha_buf->data[Y], alpha_linesize,
Y                 126 libavfilter/vf_avgblur_opencl.c     s->radius[Y] = s->luma_param.radius;
Y                 130 libavfilter/vf_avgblur_opencl.c     s->power[Y] = s->luma_param.power;
Y                 101 libavfilter/vf_boxblur.c     s->radius[Y] = s->luma_param.radius;
Y                 105 libavfilter/vf_boxblur.c     s->power[Y] = s->luma_param.power;
Y                 318 libavfilter/vf_datascope.c         int Y = outlink->h / (P * 12);
Y                 323 libavfilter/vf_datascope.c         snprintf(text, sizeof(text), "%d", s->y + Y);
Y                 330 libavfilter/vf_datascope.c         Y = (outlink->h - xmaxlen) / (P * 12);
Y                 333 libavfilter/vf_datascope.c         for (y = 0; y < Y; y++) {
Y                 544 libavfilter/vf_datascope.c     int x, y, X, Y, i, w, h;
Y                 563 libavfilter/vf_datascope.c         Y = (in->height - s->wh) * s->wy;
Y                 565 libavfilter/vf_datascope.c         Y = (in->height - s->wh) * -s->wy;
Y                 570 libavfilter/vf_datascope.c             s->y + s->h >= Y && (s->y + s->h <= Y + s->wh)) {
Y                 577 libavfilter/vf_datascope.c             s->y + s->h >= Y && (s->y + s->h <= Y + s->wh)) {
Y                 578 libavfilter/vf_datascope.c             Y = (in->height - s->wh) * (1 + s->wy);
Y                 585 libavfilter/vf_datascope.c                        Y,
Y                 596 libavfilter/vf_datascope.c                               x * w + (s->ww - 4 - (s->w * w)) / 2 + X, y * h + 2 + Y, w, h);
Y                 658 libavfilter/vf_datascope.c     draw_text(&s->draw, out, &s->white,        X + 28, Y + s->ww +  5,           text, 0);
Y                 663 libavfilter/vf_datascope.c         draw_text(&s->draw, out, s->colors[i], X + 28, Y + s->ww + 15 * (i + 1), text, 0);
Y                 666 libavfilter/vf_datascope.c     draw_text(&s->draw, out, &s->white,        X + 28, Y + s->ww + 15 * (0 + 5), text, 0);
Y                 671 libavfilter/vf_datascope.c         draw_text(&s->draw, out, s->colors[i], X + 28, Y + s->ww + 15 * (i + 6), text, 0);
Y                 107 libavfilter/vf_displace.c                     int Y = y + ysrc[x] - 128;
Y                 110 libavfilter/vf_displace.c                     if (Y < 0 || Y >= h || X < 0 || X >= w)
Y                 113 libavfilter/vf_displace.c                         dst[x] = src[Y * slinesize + X];
Y                 118 libavfilter/vf_displace.c                     int Y = av_clip(y + ysrc[x] - 128, 0, h - 1);
Y                 120 libavfilter/vf_displace.c                     dst[x] = src[Y * slinesize + X];
Y                 125 libavfilter/vf_displace.c                     int Y = (y + ysrc[x] - 128) % h;
Y                 128 libavfilter/vf_displace.c                     if (Y < 0)
Y                 129 libavfilter/vf_displace.c                         Y += h;
Y                 132 libavfilter/vf_displace.c                     dst[x] = src[Y * slinesize + X];
Y                 137 libavfilter/vf_displace.c                     int Y = y + ysrc[x] - 128;
Y                 140 libavfilter/vf_displace.c                     if (Y < 0)
Y                 141 libavfilter/vf_displace.c                         Y = (-Y) % h;
Y                 144 libavfilter/vf_displace.c                     if (Y >= h)
Y                 145 libavfilter/vf_displace.c                         Y = h - (Y % h) - 1;
Y                 148 libavfilter/vf_displace.c                     dst[x] = src[Y * slinesize + X];
Y                 183 libavfilter/vf_displace.c                     int Y = y + (ysrc[x * step + c] - 128);
Y                 186 libavfilter/vf_displace.c                     if (Y < 0 || Y >= h || X < 0 || X >= w)
Y                 189 libavfilter/vf_displace.c                         dst[x * step + c] = src[Y * slinesize + X * step + c];
Y                 196 libavfilter/vf_displace.c                     int Y = av_clip(y + (ysrc[x * step + c] - 128), 0, h - 1);
Y                 199 libavfilter/vf_displace.c                     dst[x * step + c] = src[Y * slinesize + X * step + c];
Y                 206 libavfilter/vf_displace.c                     int Y = (y + (ysrc[x * step + c] - 128)) % h;
Y                 209 libavfilter/vf_displace.c                     if (Y < 0)
Y                 210 libavfilter/vf_displace.c                         Y += h;
Y                 213 libavfilter/vf_displace.c                     dst[x * step + c] = src[Y * slinesize + X * step + c];
Y                 220 libavfilter/vf_displace.c                     int Y = y + ysrc[x * step + c] - 128;
Y                 223 libavfilter/vf_displace.c                     if (Y < 0)
Y                 224 libavfilter/vf_displace.c                         Y = (-Y) % h;
Y                 227 libavfilter/vf_displace.c                     if (Y >= h)
Y                 228 libavfilter/vf_displace.c                         Y = h - (Y % h) - 1;
Y                 231 libavfilter/vf_displace.c                     dst[x * step + c] = src[Y * slinesize + X * step + c];
Y                  99 libavfilter/vf_drawbox.c         s->yuv_color[Y] = RGB_TO_Y_CCIR(rgba_color[0], rgba_color[1], rgba_color[2]);
Y                 200 libavfilter/vf_drawbox.c            s->yuv_color[Y], s->yuv_color[U], s->yuv_color[V], s->yuv_color[A]);
Y                 239 libavfilter/vf_drawbox.c                         row[0][x           ] = s->yuv_color[Y];
Y                 264 libavfilter/vf_drawbox.c                         row[0][x                 ] = (1 - alpha) * row[0][x                 ] + alpha * s->yuv_color[Y];
Y                 411 libavfilter/vf_drawbox.c                         row[0][x                  ] = drawgrid->yuv_color[Y];
Y                 436 libavfilter/vf_drawbox.c                         row[0][x                  ] = (1 - alpha) * row[0][x                  ] + alpha * drawgrid->yuv_color[Y];
Y                  81 libavfilter/vf_fftfilt.c     { "dc_Y",  "adjust gain in Y plane",              OFFSET(dc[Y]),      AV_OPT_TYPE_INT,    {.i64 = 0},      0,     1000,     FLAGS },
Y                  84 libavfilter/vf_fftfilt.c     { "weight_Y", "set luminance expression in Y plane",   OFFSET(weight_str[Y]), AV_OPT_TYPE_STRING, {.str = "1"}, 0, 0, FLAGS },
Y                 101 libavfilter/vf_fftfilt.c static double weight_Y(void *priv, double x, double y) { return lum(priv, x, y, Y); }
Y                 218 libavfilter/vf_fftfilt.c         s->dc[U] = s->dc[Y];
Y                 219 libavfilter/vf_fftfilt.c         s->dc[V] = s->dc[Y];
Y                 226 libavfilter/vf_fftfilt.c         s->weight_str[U] = av_strdup(s->weight_str[Y]);
Y                 227 libavfilter/vf_fftfilt.c         s->weight_str[V] = av_strdup(s->weight_str[Y]);
Y                 330 libavfilter/vf_fillborders.c     s->yuv_color[Y] = RGB_TO_Y_CCIR(s->rgba_color[R], s->rgba_color[G], s->rgba_color[B]);
Y                  72 libavfilter/vf_geq.c     { "lum_expr",   "set luminance expression",   OFFSET(expr_str[Y]), AV_OPT_TYPE_STRING, {.str=NULL}, 0, 0, FLAGS },
Y                  73 libavfilter/vf_geq.c     { "lum",        "set luminance expression",   OFFSET(expr_str[Y]), AV_OPT_TYPE_STRING, {.str=NULL}, 0, 0, FLAGS },
Y                 229 libavfilter/vf_geq.c     if (!geq->expr_str[Y] && !geq->expr_str[G] && !geq->expr_str[B] && !geq->expr_str[R]) {
Y                 234 libavfilter/vf_geq.c     geq->is_rgb = !geq->expr_str[Y];
Y                 236 libavfilter/vf_geq.c     if ((geq->expr_str[Y] || geq->expr_str[U] || geq->expr_str[V]) && (geq->expr_str[G] || geq->expr_str[B] || geq->expr_str[R])) {
Y                 244 libavfilter/vf_geq.c         geq->expr_str[U] = av_strdup(geq->expr_str[Y]);
Y                 245 libavfilter/vf_geq.c         geq->expr_str[V] = av_strdup(geq->expr_str[Y]);
Y                  91 libavfilter/vf_lut.c     { "y",  "set Y expression",            OFFSET(comp_expr_str[Y]),  AV_OPT_TYPE_STRING, { .str = "clipval" }, .flags = FLAGS },
Y                 266 libavfilter/vf_lut.c         min[Y] = 16 * (1 << (desc->comp[0].depth - 8));
Y                 270 libavfilter/vf_lut.c         max[Y] = 235 * (1 << (desc->comp[0].depth - 8));
Y                  83 libavfilter/vf_vectorscope.c                        int X, int Y, int D, int P);
Y                 961 libavfilter/vf_vectorscope.c static void none_graticule(VectorscopeContext *s, AVFrame *out, int X, int Y, int D, int P)
Y                1068 libavfilter/vf_vectorscope.c static void color_graticule16(VectorscopeContext *s, AVFrame *out, int X, int Y, int D, int P)
Y                1076 libavfilter/vf_vectorscope.c         int y = positions[P][i][Y];
Y                1081 libavfilter/vf_vectorscope.c         draw_dots16((uint16_t *)(out->data[Y] + y * out->linesize[Y] + x * 2), out->linesize[Y] / 2, y, o);
Y                1088 libavfilter/vf_vectorscope.c         int y = positions[P][12][Y];
Y                1093 libavfilter/vf_vectorscope.c         draw_dots16((uint16_t *)(out->data[Y] + y * out->linesize[Y] + x * 2), out->linesize[Y] / 2, y, o);
Y                1100 libavfilter/vf_vectorscope.c         int y = positions[P][13][Y];
Y                1105 libavfilter/vf_vectorscope.c         draw_dots16((uint16_t *)(out->data[Y] + y * out->linesize[Y] + x * 2), out->linesize[Y] / 2, y, o);
Y                1113 libavfilter/vf_vectorscope.c         int y = positions[P][i][Y];
Y                1118 libavfilter/vf_vectorscope.c         color[Y] = y;
Y                1136 libavfilter/vf_vectorscope.c static void color_graticule(VectorscopeContext *s, AVFrame *out, int X, int Y, int D, int P)
Y                1143 libavfilter/vf_vectorscope.c         int y = positions[P][i][Y];
Y                1148 libavfilter/vf_vectorscope.c         draw_dots(out->data[Y] + y * out->linesize[Y] + x, out->linesize[Y], y, o);
Y                1155 libavfilter/vf_vectorscope.c         int y = positions[P][12][Y];
Y                1160 libavfilter/vf_vectorscope.c         draw_dots(out->data[Y] + y * out->linesize[Y] + x, out->linesize[Y], y, o);
Y                1167 libavfilter/vf_vectorscope.c         int y = positions[P][13][Y];
Y                1172 libavfilter/vf_vectorscope.c         draw_dots(out->data[Y] + y * out->linesize[Y] + x, out->linesize[Y], y, o);
Y                1180 libavfilter/vf_vectorscope.c         int y = positions[P][i][Y];
Y                1185 libavfilter/vf_vectorscope.c         color[Y] = y;
Y                1202 libavfilter/vf_vectorscope.c static void green_graticule16(VectorscopeContext *s, AVFrame *out, int X, int Y, int D, int P)
Y                1211 libavfilter/vf_vectorscope.c         int y = positions[P][i][Y];
Y                1222 libavfilter/vf_vectorscope.c         int y = positions[P][12][Y];
Y                1233 libavfilter/vf_vectorscope.c         int y = positions[P][13][Y];
Y                1245 libavfilter/vf_vectorscope.c         int y = positions[P][i][Y];
Y                1262 libavfilter/vf_vectorscope.c static void green_graticule(VectorscopeContext *s, AVFrame *out, int X, int Y, int D, int P)
Y                1269 libavfilter/vf_vectorscope.c         int y = positions[P][i][Y];
Y                1280 libavfilter/vf_vectorscope.c         int y = positions[P][12][Y];
Y                1291 libavfilter/vf_vectorscope.c         int y = positions[P][13][Y];
Y                1303 libavfilter/vf_vectorscope.c         int y = positions[P][i][Y];
Y                1320 libavfilter/vf_vectorscope.c static void invert_graticule16(VectorscopeContext *s, AVFrame *out, int X, int Y, int D, int P)
Y                1328 libavfilter/vf_vectorscope.c         int y = positions[P][i][Y];
Y                1332 libavfilter/vf_vectorscope.c         draw_idots16((uint16_t *)(out->data[Y] + y * out->linesize[Y] + x * 2), out->linesize[Y] / 2, max, o);
Y                1339 libavfilter/vf_vectorscope.c         int y = positions[P][12][Y];
Y                1343 libavfilter/vf_vectorscope.c         draw_idots16((uint16_t *)(out->data[Y] + y * out->linesize[Y] + x * 2), out->linesize[Y] / 2, max, o);
Y                1350 libavfilter/vf_vectorscope.c         int y = positions[P][13][Y];
Y                1354 libavfilter/vf_vectorscope.c         draw_idots16((uint16_t *)(out->data[Y] + y * out->linesize[Y] + x * 2), out->linesize[Y] / 2, max, o);
Y                1362 libavfilter/vf_vectorscope.c         int y = positions[P][i][Y];
Y                1379 libavfilter/vf_vectorscope.c static void invert_graticule(VectorscopeContext *s, AVFrame *out, int X, int Y, int D, int P)
Y                1386 libavfilter/vf_vectorscope.c         int y = positions[P][i][Y];
Y                1390 libavfilter/vf_vectorscope.c         draw_idots(out->data[Y] + y * out->linesize[Y] + x, out->linesize[Y], o);
Y                1397 libavfilter/vf_vectorscope.c         int y = positions[P][12][Y];
Y                1401 libavfilter/vf_vectorscope.c         draw_idots(out->data[Y] + y * out->linesize[Y] + x, out->linesize[Y], o);
Y                1408 libavfilter/vf_vectorscope.c         int y = positions[P][13][Y];
Y                1412 libavfilter/vf_vectorscope.c         draw_idots(out->data[Y] + y * out->linesize[Y] + x, out->linesize[Y], o);
Y                1420 libavfilter/vf_vectorscope.c         int y = positions[P][i][Y];
Y                 772 libavutil/hwcontext_qsv.c         surface->Data.Y  = frame->data[0];
Y                 777 libavutil/hwcontext_qsv.c         surface->Data.Y = frame->data[0];
Y                 790 libavutil/hwcontext_qsv.c         surface->Data.Y = frame->data[0];
Y                 614 libswscale/output.c             int Y;
Y                 616 libswscale/output.c             Y = (buf0[i + 0] * yalpha1 + buf1[i + 0] * yalpha) >> 19;
Y                 617 libswscale/output.c             Y += (7*err + 1*c->dither_error[0][i] + 5*c->dither_error[0][i+1] + 3*c->dither_error[0][i+2] + 8 - 256)>>4;
Y                 619 libswscale/output.c             acc = 2*acc + (Y >= 128);
Y                 620 libswscale/output.c             Y -= 220*(acc&1);
Y                 623 libswscale/output.c             err += (7*Y + 1*c->dither_error[0][i+1] + 5*c->dither_error[0][i+2] + 3*c->dither_error[0][i+3] + 8 - 256)>>4;
Y                 624 libswscale/output.c             c->dither_error[0][i+1] = Y;
Y                 634 libswscale/output.c             int Y, acc = 0;
Y                 636 libswscale/output.c             Y = (buf0[i + 0] * yalpha1 + buf1[i + 0] * yalpha) >> 19;
Y                 637 libswscale/output.c             accumulate_bit(acc, Y + d128[0]);
Y                 638 libswscale/output.c             Y = (buf0[i + 1] * yalpha1 + buf1[i + 1] * yalpha) >> 19;
Y                 639 libswscale/output.c             accumulate_bit(acc, Y + d128[1]);
Y                 640 libswscale/output.c             Y = (buf0[i + 2] * yalpha1 + buf1[i + 2] * yalpha) >> 19;
Y                 641 libswscale/output.c             accumulate_bit(acc, Y + d128[2]);
Y                 642 libswscale/output.c             Y = (buf0[i + 3] * yalpha1 + buf1[i + 3] * yalpha) >> 19;
Y                 643 libswscale/output.c             accumulate_bit(acc, Y + d128[3]);
Y                 644 libswscale/output.c             Y = (buf0[i + 4] * yalpha1 + buf1[i + 4] * yalpha) >> 19;
Y                 645 libswscale/output.c             accumulate_bit(acc, Y + d128[4]);
Y                 646 libswscale/output.c             Y = (buf0[i + 5] * yalpha1 + buf1[i + 5] * yalpha) >> 19;
Y                 647 libswscale/output.c             accumulate_bit(acc, Y + d128[5]);
Y                 648 libswscale/output.c             Y = (buf0[i + 6] * yalpha1 + buf1[i + 6] * yalpha) >> 19;
Y                 649 libswscale/output.c             accumulate_bit(acc, Y + d128[6]);
Y                 650 libswscale/output.c             Y = (buf0[i + 7] * yalpha1 + buf1[i + 7] * yalpha) >> 19;
Y                 651 libswscale/output.c             accumulate_bit(acc, Y + d128[7]);
Y                 671 libswscale/output.c             int Y;
Y                 673 libswscale/output.c             Y = ((buf0[i + 0] + 64) >> 7);
Y                 674 libswscale/output.c             Y += (7*err + 1*c->dither_error[0][i] + 5*c->dither_error[0][i+1] + 3*c->dither_error[0][i+2] + 8 - 256)>>4;
Y                 676 libswscale/output.c             acc = 2*acc + (Y >= 128);
Y                 677 libswscale/output.c             Y -= 220*(acc&1);
Y                 680 libswscale/output.c             err += (7*Y + 1*c->dither_error[0][i+1] + 5*c->dither_error[0][i+2] + 3*c->dither_error[0][i+3] + 8 - 256)>>4;
Y                 681 libswscale/output.c             c->dither_error[0][i+1] = Y;
Y                 907 libswscale/output.c         int Y = -0x40000000;
Y                 911 libswscale/output.c             Y += lumSrc[j][i] * lumFilter[j];
Y                 913 libswscale/output.c         Y >>= 15;
Y                 914 libswscale/output.c         Y += (1<<3) + 0x8000;
Y                 915 libswscale/output.c         Y = av_clip_uint16(Y);
Y                 927 libswscale/output.c         output_pixel(&dest[2 * i    ], Y);
Y                 949 libswscale/output.c         int Y = (buf0[i] * yalpha1 + buf1[i] * yalpha) >> 15;
Y                 952 libswscale/output.c         Y = av_clip_uint16(Y);
Y                 959 libswscale/output.c         output_pixel(&dest[2 * i    ], Y);
Y                 974 libswscale/output.c         int Y = buf0[i] >> 3;/* 19 - 16 */
Y                 977 libswscale/output.c         Y = av_clip_uint16(Y);
Y                 985 libswscale/output.c         output_pixel(&dest[2 * i    ], Y);
Y                1253 libswscale/output.c         int Y  = -0x40000000;
Y                1259 libswscale/output.c             Y += lumSrc[j][i]  * (unsigned)lumFilter[j];
Y                1276 libswscale/output.c         Y  >>= 14; // 10
Y                1277 libswscale/output.c         Y += 0x10000;
Y                1282 libswscale/output.c         Y -= c->yuv2rgb_y_offset;
Y                1283 libswscale/output.c         Y *= c->yuv2rgb_y_coeff;
Y                1284 libswscale/output.c         Y += 1 << 13; // 21
Y                1292 libswscale/output.c         output_pixel(&dest[0], av_clip_uintp2(R_B + Y, 30) >> 14);
Y                1293 libswscale/output.c         output_pixel(&dest[1], av_clip_uintp2(  G + Y, 30) >> 14);
Y                1294 libswscale/output.c         output_pixel(&dest[2], av_clip_uintp2(B_R + Y, 30) >> 14);
Y                1325 libswscale/output.c         int Y  = (buf0[i]     * yalpha1  + buf1[i]     * yalpha) >> 14;
Y                1330 libswscale/output.c         Y -= c->yuv2rgb_y_offset;
Y                1331 libswscale/output.c         Y *= c->yuv2rgb_y_coeff;
Y                1332 libswscale/output.c         Y += 1 << 13;
Y                1344 libswscale/output.c         output_pixel(&dest[0], av_clip_uintp2(R_B + Y, 30) >> 14);
Y                1345 libswscale/output.c         output_pixel(&dest[1], av_clip_uintp2(  G + Y, 30) >> 14);
Y                1346 libswscale/output.c         output_pixel(&dest[2], av_clip_uintp2(B_R + Y, 30) >> 14);
Y                1368 libswscale/output.c             int Y  = (buf0[i]) >> 2;
Y                1373 libswscale/output.c             Y -= c->yuv2rgb_y_offset;
Y                1374 libswscale/output.c             Y *= c->yuv2rgb_y_coeff;
Y                1375 libswscale/output.c             Y += 1 << 13;
Y                1387 libswscale/output.c             output_pixel(&dest[0], av_clip_uintp2(R_B + Y, 30) >> 14);
Y                1388 libswscale/output.c             output_pixel(&dest[1], av_clip_uintp2(  G + Y, 30) >> 14);
Y                1389 libswscale/output.c             output_pixel(&dest[2], av_clip_uintp2(B_R + Y, 30) >> 14);
Y                1401 libswscale/output.c             int Y  = (buf0[i]    ) >> 2;
Y                1406 libswscale/output.c             Y -= c->yuv2rgb_y_offset;
Y                1407 libswscale/output.c             Y *= c->yuv2rgb_y_coeff;
Y                1408 libswscale/output.c             Y += 1 << 13;
Y                1420 libswscale/output.c             output_pixel(&dest[0], av_clip_uintp2(R_B + Y, 30) >> 14);
Y                1421 libswscale/output.c             output_pixel(&dest[1], av_clip_uintp2(  G + Y, 30) >> 14);
Y                1422 libswscale/output.c             output_pixel(&dest[2], av_clip_uintp2(B_R + Y, 30) >> 14);
Y                1844 libswscale/output.c     uint8_t *dest, int i, int Y, int A, int U, int V,
Y                1850 libswscale/output.c     Y -= c->yuv2rgb_y_offset;
Y                1851 libswscale/output.c     Y *= c->yuv2rgb_y_coeff;
Y                1852 libswscale/output.c     Y += 1 << 21;
Y                1853 libswscale/output.c     R = (unsigned)Y + V*c->yuv2rgb_v2r_coeff;
Y                1854 libswscale/output.c     G = (unsigned)Y + V*c->yuv2rgb_v2g_coeff + U*c->yuv2rgb_u2g_coeff;
Y                1855 libswscale/output.c     B = (unsigned)Y +                          U*c->yuv2rgb_u2b_coeff;
Y                2001 libswscale/output.c         int Y = 1<<9;
Y                2006 libswscale/output.c             Y += lumSrc[j][i] * lumFilter[j];
Y                2012 libswscale/output.c         Y >>= 10;
Y                2024 libswscale/output.c         yuv2rgb_write_full(c, dest, i, Y, A, U, V, y, target, hasAlpha, err);
Y                2059 libswscale/output.c         int Y = ( buf0[i] * yalpha1  +  buf1[i] * yalpha             ) >> 10; //FIXME rounding
Y                2069 libswscale/output.c         yuv2rgb_write_full(c, dest, i, Y, A, U, V, y, target, hasAlpha, err);
Y                2096 libswscale/output.c             int Y = buf0[i] * 4;
Y                2106 libswscale/output.c             yuv2rgb_write_full(c, dest, i, Y, A, U, V, y, target, hasAlpha, err);
Y                2113 libswscale/output.c             int Y = buf0[i] * 4;
Y                2123 libswscale/output.c             yuv2rgb_write_full(c, dest, i, Y, A, U, V, y, target, hasAlpha, err);
Y                2175 libswscale/output.c         int Y = 1 << 9;
Y                2181 libswscale/output.c             Y += lumSrc[j][i] * lumFilter[j];
Y                2188 libswscale/output.c         Y >>= 10;
Y                2202 libswscale/output.c         Y -= c->yuv2rgb_y_offset;
Y                2203 libswscale/output.c         Y *= c->yuv2rgb_y_coeff;
Y                2204 libswscale/output.c         Y += 1 << (SH-1);
Y                2205 libswscale/output.c         R = Y + V * c->yuv2rgb_v2r_coeff;
Y                2206 libswscale/output.c         G = Y + V * c->yuv2rgb_v2g_coeff + U * c->yuv2rgb_u2g_coeff;
Y                2207 libswscale/output.c         B = Y +                            U * c->yuv2rgb_u2b_coeff;
Y                2259 libswscale/output.c         int Y = -0x40000000;
Y                2265 libswscale/output.c             Y += lumSrc[j][i] * (unsigned)lumFilter[j];
Y                2272 libswscale/output.c         Y >>= 14;
Y                2273 libswscale/output.c         Y += 0x10000;
Y                2287 libswscale/output.c         Y -= c->yuv2rgb_y_offset;
Y                2288 libswscale/output.c         Y *= c->yuv2rgb_y_coeff;
Y                2289 libswscale/output.c         Y += 1 << 13;
Y                2294 libswscale/output.c         R = av_clip_uintp2(Y + R, 30);
Y                2295 libswscale/output.c         G = av_clip_uintp2(Y + G, 30);
Y                2296 libswscale/output.c         B = av_clip_uintp2(Y + B, 30);
Y                2335 libswscale/output.c         int Y = -0x40000000;
Y                2341 libswscale/output.c             Y += lumSrc[j][i] * (unsigned)lumFilter[j];
Y                2348 libswscale/output.c         Y >>= 14;
Y                2349 libswscale/output.c         Y += 0x10000;
Y                2363 libswscale/output.c         Y -= c->yuv2rgb_y_offset;
Y                2364 libswscale/output.c         Y *= c->yuv2rgb_y_coeff;
Y                2365 libswscale/output.c         Y += 1 << 13;
Y                2370 libswscale/output.c         R = av_clip_uintp2(Y + R, 30);
Y                2371 libswscale/output.c         G = av_clip_uintp2(Y + G, 30);
Y                2372 libswscale/output.c         B = av_clip_uintp2(Y + B, 30);
Y                2401 libswscale/output.c         int Y = (buf0[i] + 64) >> 7;
Y                2404 libswscale/output.c         Y = av_clip_uint8(Y);
Y                2412 libswscale/output.c         dest[i * 2    ] = Y;
Y                2433 libswscale/output.c         int Y = (buf0[i] * yalpha1 + buf1[i] * yalpha) >> 19;
Y                2436 libswscale/output.c         Y = av_clip_uint8(Y);
Y                2443 libswscale/output.c         dest[i * 2    ] = Y;
Y                2460 libswscale/output.c         int Y = 1 << 18, A = 1 << 18;
Y                2463 libswscale/output.c             Y += lumSrc[j][i] * lumFilter[j];
Y                2465 libswscale/output.c         Y >>= 19;
Y                2466 libswscale/output.c         if (Y  & 0x100)
Y                2467 libswscale/output.c             Y = av_clip_uint8(Y);
Y                2479 libswscale/output.c         dest[2 * i    ] = Y;
Y                2499 libswscale/output.c         int Y = 1 << 14, U = 1 << 14;
Y                2503 libswscale/output.c         Y -= 0x40000000;
Y                2509 libswscale/output.c             Y += lumSrc[j][i] * (unsigned)lumFilter[j];
Y                2521 libswscale/output.c         Y = 0x8000 + av_clip_int16(Y >> 15);
Y                2527 libswscale/output.c         AV_WL16(dest + 8 * i + 2, Y);
Y                 254 libswscale/ppc/yuv2rgb_altivec.c static inline void cvtyuvtoRGB(SwsContext *c, vector signed short Y,
Y                 261 libswscale/ppc/yuv2rgb_altivec.c     Y = vec_mradds(Y, c->CY, c->OY);
Y                 269 libswscale/ppc/yuv2rgb_altivec.c     *B = vec_mradds(ux, c->CBU, Y);
Y                 273 libswscale/ppc/yuv2rgb_altivec.c     *R = vec_mradds(vx, c->CRV, Y);
Y                 276 libswscale/ppc/yuv2rgb_altivec.c     uvx = vec_mradds(U, c->CGU, Y);
Y                 471 libswscale/ppc/yuv2rgb_altivec.c     vector signed short Y, U, V;
Y                 488 libswscale/ppc/yuv2rgb_altivec.c             Y = (vector signed short)
Y                 491 libswscale/ppc/yuv2rgb_altivec.c             cvtyuvtoRGB(c, Y, U, V, &R0, &G0, &B0);
Y                 499 libswscale/ppc/yuv2rgb_altivec.c             Y = (vector signed short)
Y                 502 libswscale/ppc/yuv2rgb_altivec.c             cvtyuvtoRGB(c, Y, U, V, &R1, &G1, &B1);
Y                 668 libswscale/rgb2rgb_template.c             unsigned int Y = ((ry * r + gy * g + by * b) >> RGB2YUV_SHIFT) +  16;
Y                 674 libswscale/rgb2rgb_template.c             ydst[2 * i] = Y;
Y                 680 libswscale/rgb2rgb_template.c             Y = ((ry * r + gy * g + by * b) >> RGB2YUV_SHIFT) + 16;
Y                 681 libswscale/rgb2rgb_template.c             ydst[2 * i + 1] = Y;
Y                 694 libswscale/rgb2rgb_template.c             unsigned int Y = ((ry * r + gy * g + by * b) >> RGB2YUV_SHIFT) + 16;
Y                 696 libswscale/rgb2rgb_template.c             ydst[2 * i] = Y;
Y                 702 libswscale/rgb2rgb_template.c             Y = ((ry * r + gy * g + by * b) >> RGB2YUV_SHIFT) + 16;
Y                 703 libswscale/rgb2rgb_template.c             ydst[2 * i + 1] = Y;
Y                  78 libswscale/yuv2rgb.c     Y              = src[2 * i];                    \
Y                  79 libswscale/yuv2rgb.c     dst[2 * i]     = r[Y] + g[Y] + b[Y];            \
Y                  80 libswscale/yuv2rgb.c     Y              = src[2 * i + 1];                \
Y                  81 libswscale/yuv2rgb.c     dst[2 * i + 1] = r[Y] + g[Y] + b[Y];
Y                  84 libswscale/yuv2rgb.c     Y              = src[2 * i];                    \
Y                  85 libswscale/yuv2rgb.c     dst[6 * i + 0] = r[Y];                          \
Y                  86 libswscale/yuv2rgb.c     dst[6 * i + 1] = g[Y];                          \
Y                  87 libswscale/yuv2rgb.c     dst[6 * i + 2] = b[Y];                          \
Y                  88 libswscale/yuv2rgb.c     Y              = src[2 * i + 1];                \
Y                  89 libswscale/yuv2rgb.c     dst[6 * i + 3] = r[Y];                          \
Y                  90 libswscale/yuv2rgb.c     dst[6 * i + 4] = g[Y];                          \
Y                  91 libswscale/yuv2rgb.c     dst[6 * i + 5] = b[Y];
Y                  94 libswscale/yuv2rgb.c     Y              = src[2 * i];                    \
Y                  95 libswscale/yuv2rgb.c     dst[6 * i + 0] = b[Y];                          \
Y                  96 libswscale/yuv2rgb.c     dst[6 * i + 1] = g[Y];                          \
Y                  97 libswscale/yuv2rgb.c     dst[6 * i + 2] = r[Y];                          \
Y                  98 libswscale/yuv2rgb.c     Y              = src[2 * i + 1];                \
Y                  99 libswscale/yuv2rgb.c     dst[6 * i + 3] = b[Y];                          \
Y                 100 libswscale/yuv2rgb.c     dst[6 * i + 4] = g[Y];                          \
Y                 101 libswscale/yuv2rgb.c     dst[6 * i + 5] = r[Y];
Y                 104 libswscale/yuv2rgb.c     Y              = ysrc[2 * i];                                       \
Y                 105 libswscale/yuv2rgb.c     dst[2 * i]     = r[Y] + g[Y] + b[Y] + (asrc[2 * i]     << s);       \
Y                 106 libswscale/yuv2rgb.c     Y              = ysrc[2 * i + 1];                                   \
Y                 107 libswscale/yuv2rgb.c     dst[2 * i + 1] = r[Y] + g[Y] + b[Y] + (asrc[2 * i + 1] << s);
Y                 110 libswscale/yuv2rgb.c     Y                = src[ 2 * i];                 \
Y                 111 libswscale/yuv2rgb.c     dst[12 * i +  0] = dst[12 * i +  1] = r[Y];     \
Y                 112 libswscale/yuv2rgb.c     dst[12 * i +  2] = dst[12 * i +  3] = g[Y];     \
Y                 113 libswscale/yuv2rgb.c     dst[12 * i +  4] = dst[12 * i +  5] = b[Y];     \
Y                 114 libswscale/yuv2rgb.c     Y                = src[ 2 * i + 1];             \
Y                 115 libswscale/yuv2rgb.c     dst[12 * i +  6] = dst[12 * i +  7] = r[Y];     \
Y                 116 libswscale/yuv2rgb.c     dst[12 * i +  8] = dst[12 * i +  9] = g[Y];     \
Y                 117 libswscale/yuv2rgb.c     dst[12 * i + 10] = dst[12 * i + 11] = b[Y];
Y                 120 libswscale/yuv2rgb.c     Y                = src[2 * i];                  \
Y                 121 libswscale/yuv2rgb.c     dst[12 * i +  0] = dst[12 * i +  1] = b[Y];     \
Y                 122 libswscale/yuv2rgb.c     dst[12 * i +  2] = dst[12 * i +  3] = g[Y];     \
Y                 123 libswscale/yuv2rgb.c     dst[12 * i +  4] = dst[12 * i +  5] = r[Y];     \
Y                 124 libswscale/yuv2rgb.c     Y                = src[2  * i +  1];            \
Y                 125 libswscale/yuv2rgb.c     dst[12 * i +  6] = dst[12 * i +  7] = b[Y];     \
Y                 126 libswscale/yuv2rgb.c     dst[12 * i +  8] = dst[12 * i +  9] = g[Y];     \
Y                 127 libswscale/yuv2rgb.c     dst[12 * i + 10] = dst[12 * i + 11] = r[Y];
Y                 158 libswscale/yuv2rgb.c                 int av_unused U, V, Y;                                      \
Y                 169 libswscale/yuv2rgb.c         int av_unused Y, U, V;                      \
Y                 414 libswscale/yuv2rgb.c     Y              = src[2 * i];                    \
Y                 415 libswscale/yuv2rgb.c     dst[2 * i]     = r[Y + d16[0 + o]] +            \
Y                 416 libswscale/yuv2rgb.c                      g[Y + e16[0 + o]] +            \
Y                 417 libswscale/yuv2rgb.c                      b[Y + f16[0 + o]];             \
Y                 418 libswscale/yuv2rgb.c     Y              = src[2 * i + 1];                \
Y                 419 libswscale/yuv2rgb.c     dst[2 * i + 1] = r[Y + d16[1 + o]] +            \
Y                 420 libswscale/yuv2rgb.c                      g[Y + e16[1 + o]] +            \
Y                 421 libswscale/yuv2rgb.c                      b[Y + f16[1 + o]];
Y                 444 libswscale/yuv2rgb.c     Y              = src[2 * i];                    \
Y                 445 libswscale/yuv2rgb.c     dst[2 * i]     = r[Y + d16[0 + o]] +            \
Y                 446 libswscale/yuv2rgb.c                      g[Y + d16[1 + o]] +            \
Y                 447 libswscale/yuv2rgb.c                      b[Y + e16[0 + o]];             \
Y                 448 libswscale/yuv2rgb.c     Y              = src[2 * i + 1];                \
Y                 449 libswscale/yuv2rgb.c     dst[2 * i + 1] = r[Y + d16[1 + o]] +            \
Y                 450 libswscale/yuv2rgb.c                      g[Y + d16[0 + o]] +            \
Y                 451 libswscale/yuv2rgb.c                      b[Y + e16[1 + o]];
Y                 474 libswscale/yuv2rgb.c     Y              = src[2 * i];                    \
Y                 475 libswscale/yuv2rgb.c     dst[2 * i]     = r[Y + d16[0 + o]] +            \
Y                 476 libswscale/yuv2rgb.c                      g[Y + d16[0 + o]] +            \
Y                 477 libswscale/yuv2rgb.c                      b[Y + d16[0 + o]];             \
Y                 478 libswscale/yuv2rgb.c     Y              = src[2 * i + 1];                \
Y                 479 libswscale/yuv2rgb.c     dst[2 * i + 1] = r[Y + d16[1 + o]] +            \
Y                 480 libswscale/yuv2rgb.c                      g[Y + d16[1 + o]] +            \
Y                 481 libswscale/yuv2rgb.c                      b[Y + d16[1 + o]];
Y                 506 libswscale/yuv2rgb.c     Y              = src[2 * i];                    \
Y                 507 libswscale/yuv2rgb.c     dst[2 * i]     = r[Y + d32[0 + o]] +            \
Y                 508 libswscale/yuv2rgb.c                      g[Y + d32[0 + o]] +            \
Y                 509 libswscale/yuv2rgb.c                      b[Y + d64[0 + o]];             \
Y                 510 libswscale/yuv2rgb.c     Y              = src[2 * i + 1];                \
Y                 511 libswscale/yuv2rgb.c     dst[2 * i + 1] = r[Y + d32[1 + o]] +            \
Y                 512 libswscale/yuv2rgb.c                      g[Y + d32[1 + o]] +            \
Y                 513 libswscale/yuv2rgb.c                      b[Y + d64[1 + o]];
Y                 558 libswscale/yuv2rgb.c     Y      = src[2 * i];                            \
Y                 559 libswscale/yuv2rgb.c     acc    = r[Y + d128[0 + o]] +                   \
Y                 560 libswscale/yuv2rgb.c              g[Y +  d64[0 + o]] +                   \
Y                 561 libswscale/yuv2rgb.c              b[Y + d128[0 + o]];                    \
Y                 562 libswscale/yuv2rgb.c     Y      = src[2 * i + 1];                        \
Y                 563 libswscale/yuv2rgb.c     acc   |= (r[Y + d128[1 + o]] +                  \
Y                 564 libswscale/yuv2rgb.c               g[Y +  d64[1 + o]] +                  \
Y                 565 libswscale/yuv2rgb.c               b[Y + d128[1 + o]]) << 4;             \
Y                 610 libswscale/yuv2rgb.c     Y              = src[2 * i];                    \
Y                 611 libswscale/yuv2rgb.c     dst[2 * i]     = r[Y + d128[0 + o]] +           \
Y                 612 libswscale/yuv2rgb.c                      g[Y +  d64[0 + o]] +           \
Y                 613 libswscale/yuv2rgb.c                      b[Y + d128[0 + o]];            \
Y                 614 libswscale/yuv2rgb.c     Y              = src[2 * i + 1];                \
Y                 615 libswscale/yuv2rgb.c     dst[2 * i + 1] = r[Y + d128[1 + o]] +           \
Y                 616 libswscale/yuv2rgb.c                      g[Y +  d64[1 + o]] +           \
Y                 617 libswscale/yuv2rgb.c                      b[Y + d128[1 + o]];
Y                 658 libswscale/yuv2rgb.c     Y    = src[2 * i];                              \
Y                 659 libswscale/yuv2rgb.c     out += out + g[Y + d128[0 + o]];                \
Y                 660 libswscale/yuv2rgb.c     Y    = src[2 * i + 1];                          \
Y                 661 libswscale/yuv2rgb.c     out += out + g[Y + d128[1 + o]];
Y                 206 tests/checkasm/sbrdsp.c     declare_func(void, INTFLOAT (*Y)[2], const INTFLOAT (*X_high)[40][2],
Y                 229 tests/checkasm/sbrdsp.c     declare_func(void, INTFLOAT (*Y)[2], const AAC_FLOAT *s_m,
Y                  38 tools/yuvcmp.c     uint8_t *Y[2], *C[2][2];
Y                  56 tools/yuvcmp.c         Y[i] = malloc(lsiz);
Y                  82 tools/yuvcmp.c             v = read(fd[i], Y[i], lsiz);
Y                  91 tools/yuvcmp.c             if(Y[0][c] != Y[1][c]) {
Y                  99 tools/yuvcmp.c                            Y[0][c],
Y                 100 tools/yuvcmp.c                            Y[1][c],
Y                 162 tools/yuvcmp.c                     a = Y[0] + x * 16 + y * 16 * width;
Y                 163 tools/yuvcmp.c                     b = Y[1] + x * 16 + y * 16 * width;