shift            2423 ffmpeg.c            FIX(0.50000) * b1 + (ONE_HALF << shift) - 1) >> (SCALEBITS + shift)) + 128)
shift            2427 ffmpeg.c          FIX(0.08131) * b1 + (ONE_HALF << shift) - 1) >> (SCALEBITS + shift)) + 128)
shift             401 ffplay.c            FIX(0.50000*224.0/255.0) * b1 + (ONE_HALF << shift) - 1) >> (SCALEBITS + shift)) + 128)
shift             405 ffplay.c          FIX(0.08131*224.0/255.0) * b1 + (ONE_HALF << shift) - 1) >> (SCALEBITS + shift)) + 128)
shift             146 libavcodec/acelp_vectors.c                  rounder) >> shift);
shift             722 libavcodec/adpcm.c     diff = ((2 * delta + 1) * step) >> shift;
shift             775 libavcodec/adpcm.c     diff = delta << (7 + c->step + shift);
shift             807 libavcodec/adpcm.c     int shift,filter,f0,f1;
shift             813 libavcodec/adpcm.c         shift  = 12 - (in[4+i*2] & 15);
shift             825 libavcodec/adpcm.c             s = ( t<<shift ) + ((s_1*f0 + s_2*f1+32)>>6);
shift             840 libavcodec/adpcm.c         shift  = 12 - (in[5+i*2] & 15);
shift             850 libavcodec/adpcm.c             s = ( t<<shift ) + ((s_1*f0 + s_2*f1+32)>>6);
shift             911 libavcodec/adpcm.c     int coeff[2][2], shift[2];//used in EA MAXIS ADPCM
shift            1262 libavcodec/adpcm.c             shift[channel] = (*src & 0x0F) + 8;
shift            1268 libavcodec/adpcm.c                     int32_t sample = (int32_t)(((*(src+channel) >> i) & 0x0F) << 0x1C) >> shift[channel];
shift            1290 libavcodec/adpcm.c         uint8_t shift;
shift            1335 libavcodec/adpcm.c                     shift = (*srcC++ & 0x0F) + 8;
shift            1340 libavcodec/adpcm.c                             next_sample = (int32_t)((*srcC++ & 0x0F) << 28) >> shift;
shift            1342 libavcodec/adpcm.c                             next_sample = (int32_t)((*srcC   & 0xF0) << 24) >> shift;
shift            1373 libavcodec/adpcm.c             int coeff[2][4], shift[4];
shift            1378 libavcodec/adpcm.c                 shift[n] = (src[2]&0x0F) + 8;
shift            1387 libavcodec/adpcm.c                         int level = (int32_t)((*src & (0xF0>>i)) << (24+i)) >> shift[n];
shift             130 libavcodec/alacenc.c     int shift[MAX_LPC_ORDER];
shift             134 libavcodec/alacenc.c                                    ALAC_MAX_LPC_PRECISION, coefs, shift, 1, ORDER_METHOD_EST, ALAC_MAX_LPC_SHIFT, 1);
shift             137 libavcodec/alacenc.c     s->lpc[ch].lpc_quant = shift[opt_order-1];
shift             270 libavcodec/apedec.c     ctx->rc.help = ctx->rc.range >> shift;
shift              36 libavcodec/arm/mathops.h             : "r"(b), "r"(a), "ir"(shift), "ir"(32-shift));
shift              79 libavcodec/bfi.c             int shift = 16;
shift              81 libavcodec/bfi.c             for (j = 0; j < 3; j++, shift -= 8)
shift              84 libavcodec/bfi.c                     (avctx->extradata[i * 3 + j] >> 4)) << shift;
shift             363 libavcodec/cabac.h     int shift= (uint32_t)(c->range - 0x100)>>31;
shift             364 libavcodec/cabac.h     c->range<<= shift;
shift             365 libavcodec/cabac.h     c->low  <<= shift;
shift             279 libavcodec/cavs.h     int round = 1 << (shift - 1);
shift             292 libavcodec/cavs.h         dst[scantab[pos]] = (level_buf[coeff_num]*mul + round) >> shift;
shift              93 libavcodec/colorspace.h      FIX(0.50000) * b1 + (ONE_HALF << shift) - 1) >> (SCALEBITS + shift)) + 128)
shift              97 libavcodec/colorspace.h    FIX(0.08131) * b1 + (ONE_HALF << shift) - 1) >> (SCALEBITS + shift)) + 128)
shift             105 libavcodec/colorspace.h      FIX(0.50000*224.0/255.0) * b1 + (ONE_HALF << shift) - 1) >> (SCALEBITS + shift)) + 128)
shift             109 libavcodec/colorspace.h    FIX(0.08131*224.0/255.0) * b1 + (ONE_HALF << shift) - 1) >> (SCALEBITS + shift)) + 128)
shift             172 libavcodec/dpcm.c     int shift[2];
shift             235 libavcodec/dpcm.c         shift[0] = shift[1] = 4;
shift             249 libavcodec/dpcm.c                 shift[channel_number]++;
shift             251 libavcodec/dpcm.c                 shift[channel_number] -= (2 * (byte & 3));
shift             253 libavcodec/dpcm.c             if (shift[channel_number] < 0)
shift             254 libavcodec/dpcm.c                 shift[channel_number] = 0;
shift             256 libavcodec/dpcm.c             diff >>= shift[channel_number];
shift            1304 libavcodec/dsputil.c     const int s= 1<<shift;
shift            1321 libavcodec/dsputil.c             src_x>>=shift;
shift            1322 libavcodec/dsputil.c             src_y>>=shift;
shift            1331 libavcodec/dsputil.c                                         + r)>>(shift*2);
shift            1336 libavcodec/dsputil.c                                         + r)>>(shift*2);
shift            1343 libavcodec/dsputil.c                                         + r)>>(shift*2);
shift            4115 libavcodec/dsputil.c         res += (*v1++ * *v2++) >> shift;
shift             214 libavcodec/dsputil.h                     int dxx, int dxy, int dyx, int dyy, int shift, int r, int width, int height);
shift             510 libavcodec/dsputil.h     int32_t (*scalarproduct_int16)(int16_t *v1, int16_t *v2/*align 16*/, int len, int shift);
shift              78 libavcodec/flacenc.c     int shift;
shift             766 libavcodec/flacenc.c         res[i  ] = smp[i  ] - (p0 >> shift);
shift             767 libavcodec/flacenc.c         res[i+1] = smp[i+1] - (p1 >> shift);
shift             789 libavcodec/flacenc.c         res[i  ] = smp[i  ] - (p0 >> shift);
shift             790 libavcodec/flacenc.c         res[i+1] = smp[i+1] - (p1 >> shift);
shift             794 libavcodec/flacenc.c         case  1: encode_residual_lpc_unrolled(res, smp, n, 1, coefs, shift, 0); break;
shift             795 libavcodec/flacenc.c         case  2: encode_residual_lpc_unrolled(res, smp, n, 2, coefs, shift, 0); break;
shift             796 libavcodec/flacenc.c         case  3: encode_residual_lpc_unrolled(res, smp, n, 3, coefs, shift, 0); break;
shift             797 libavcodec/flacenc.c         case  4: encode_residual_lpc_unrolled(res, smp, n, 4, coefs, shift, 0); break;
shift             798 libavcodec/flacenc.c         case  5: encode_residual_lpc_unrolled(res, smp, n, 5, coefs, shift, 0); break;
shift             799 libavcodec/flacenc.c         case  6: encode_residual_lpc_unrolled(res, smp, n, 6, coefs, shift, 0); break;
shift             800 libavcodec/flacenc.c         case  7: encode_residual_lpc_unrolled(res, smp, n, 7, coefs, shift, 0); break;
shift             801 libavcodec/flacenc.c         case  8: encode_residual_lpc_unrolled(res, smp, n, 8, coefs, shift, 0); break;
shift             802 libavcodec/flacenc.c         default: encode_residual_lpc_unrolled(res, smp, n, order, coefs, shift, 1); break;
shift             815 libavcodec/flacenc.c     int shift[MAX_LPC_ORDER];
shift             875 libavcodec/flacenc.c                                   precision, coefs, shift, ctx->options.use_lpc,
shift             890 libavcodec/flacenc.c             encode_residual_lpc(res, smp, n, order+1, coefs[order], shift[order]);
shift             905 libavcodec/flacenc.c             encode_residual_lpc(res, smp, n, i+1, coefs[i], shift[i]);
shift             925 libavcodec/flacenc.c                 encode_residual_lpc(res, smp, n, i+1, coefs[i], shift[i]);
shift             938 libavcodec/flacenc.c     sub->shift = shift[sub->order-1];
shift             942 libavcodec/flacenc.c     encode_residual_lpc(res, smp, n, sub->order, sub->coefs, sub->shift);
shift            1206 libavcodec/flacenc.c     put_sbits(&ctx->pb, 5, sub->shift);
shift            3368 libavcodec/h263.c     int x, y, mb_v, sum, dx, dy, shift;
shift            3383 libavcodec/h263.c         shift= s->sprite_shift[0];
shift            3384 libavcodec/h263.c         if(n) dy -= 1<<(shift + a + 1);
shift            3385 libavcodec/h263.c         else  dx -= 1<<(shift + a + 1);
shift            3395 libavcodec/h263.c                 sum+= v>>shift;
shift            4506 libavcodec/h263.c     int code, val, sign, shift, l;
shift            4515 libavcodec/h263.c     shift = f_code - 1;
shift            4517 libavcodec/h263.c     if (shift) {
shift            4518 libavcodec/h263.c         val = (val - 1) << shift;
shift            4519 libavcodec/h263.c         val |= get_bits(&s->gb, shift);
shift            2014 libavcodec/h264.c             int shift = div6[q];
shift            2019 libavcodec/h264.c                     h->pps.scaling_matrix8[i][x]) << shift;
shift            2039 libavcodec/h264.c             int shift = div6[q] + 2;
shift            2044 libavcodec/h264.c                     h->pps.scaling_matrix4[i][x]) << shift;
shift              34 libavcodec/h264idct.c     block[0] += 1<<(shift-1);
shift              54 libavcodec/h264idct.c         dst[i + 0*stride]= cm[ add*dst[i + 0*stride] + ((z0 + z3) >> shift) ];
shift              55 libavcodec/h264idct.c         dst[i + 1*stride]= cm[ add*dst[i + 1*stride] + ((z1 + z2) >> shift) ];
shift              56 libavcodec/h264idct.c         dst[i + 2*stride]= cm[ add*dst[i + 2*stride] + ((z1 - z2) >> shift) ];
shift              57 libavcodec/h264idct.c         dst[i + 3*stride]= cm[ add*dst[i + 3*stride] + ((z0 - z3) >> shift) ];
shift             491 libavcodec/imgresample.c     int i, shift;
shift             495 libavcodec/imgresample.c         shift = (i == 0) ? 0 : 1;
shift             498 libavcodec/imgresample.c                         s->padtop) + s->padleft) >> shift);
shift             501 libavcodec/imgresample.c                 s->pad_owidth >> shift, s->pad_oheight >> shift,
shift             503 libavcodec/imgresample.c                     (s->topBand >> shift)) + (s->leftBand >> shift),
shift             505 libavcodec/imgresample.c                         s->rightBand) >> shift),
shift             506 libavcodec/imgresample.c                            (s->iheight - s->topBand - s->bottomBand) >> shift);
shift             263 libavcodec/jpeglsdec.c     int off = 0, stride = 1, width, shift;
shift             282 libavcodec/jpeglsdec.c         shift = point_transform + (8 - s->bits);
shift             284 libavcodec/jpeglsdec.c         shift = point_transform + (16 - s->bits);
shift             334 libavcodec/jpeglsdec.c     if(shift){ /* we need to do point transform or normalize samples */
shift             344 libavcodec/jpeglsdec.c                     src[x] <<= shift;
shift             353 libavcodec/jpeglsdec.c                     src[x] <<= shift;
shift              51 libavcodec/lpc.c         *shift = zero_shift;
shift              78 libavcodec/lpc.c     *shift = sh;
shift             166 libavcodec/lpc.c         quantize_lpc_coefs(lpc[i], i+1, precision, coefs[i], &shift[i], max_shift, zero_shift);
shift             169 libavcodec/lpc.c             quantize_lpc_coefs(lpc[i], i+1, precision, coefs[i], &shift[i], max_shift, zero_shift);
shift              68 libavcodec/mlp.h     uint8_t     shift; ///< Right shift to apply to output of filter.
shift             408 libavcodec/mlpdec.c         cp->filter_params[FIR].shift = 0;
shift             409 libavcodec/mlpdec.c         cp->filter_params[IIR].shift = 0;
shift             449 libavcodec/mlpdec.c         fp->shift = get_bits(gbp, 4);
shift             591 libavcodec/mlpdec.c                 fir->shift != iir->shift) {
shift             602 libavcodec/mlpdec.c                 fir->shift = iir->shift;
shift             631 libavcodec/mlpdec.c     unsigned int filter_shift = fp[FIR]->shift;
shift             558 libavcodec/motion_est.c         if(P_LEFT[0]       > (c->xmax<<shift)) P_LEFT[0]       = (c->xmax<<shift);
shift             569 libavcodec/motion_est.c             if(P_TOP[1]      > (c->ymax<<shift)) P_TOP[1]     = (c->ymax<<shift);
shift             570 libavcodec/motion_est.c             if(P_TOPRIGHT[0] < (c->xmin<<shift)) P_TOPRIGHT[0]= (c->xmin<<shift);
shift             571 libavcodec/motion_est.c             if(P_TOPRIGHT[0] > (c->xmax<<shift)) P_TOPRIGHT[0]= (c->xmax<<shift);
shift             572 libavcodec/motion_est.c             if(P_TOPRIGHT[1] > (c->ymax<<shift)) P_TOPRIGHT[1]= (c->ymax<<shift);
shift             583 libavcodec/motion_est.c         dmin4 = epzs_motion_search4(s, &mx4, &my4, P, block, block, s->p_mv_table, (1<<16)>>shift);
shift             821 libavcodec/motion_est.c     int shift= (flags&FLAG_QPEL) + 1;
shift             822 libavcodec/motion_est.c     int mask= (1<<shift)-1;
shift             874 libavcodec/motion_est.c             d = cmp(s, x>>shift, y>>shift, x&mask, y&mask, 0, 8, field_select0, 0, cmpf, chroma_cmpf, flags);
shift             877 libavcodec/motion_est.c             d+= cmp(s, x>>shift, y>>shift, x&mask, y&mask, 0, 8, field_select1, 1, cmpf, chroma_cmpf, flags);
shift             898 libavcodec/motion_est.c             d = cmp(s, x>>shift, y>>shift, x&mask, y&mask, 0, 8, field_select0+2, 0, cmpf, chroma_cmpf, flags);
shift             901 libavcodec/motion_est.c             d+= cmp(s, x>>shift, y>>shift, x&mask, y&mask, 0, 8, field_select1+2, 1, cmpf, chroma_cmpf, flags);
shift             918 libavcodec/motion_est.c             d+= cmp(s, x>>shift, y>>shift, x&mask, y&mask, 1, 8, i, i, cmpf, chroma_cmpf, flags);
shift             936 libavcodec/motion_est.c             d = cmp(s, x>>shift, y>>shift, x&mask, y&mask, 0, 16, 0, 0, cmpf, chroma_cmpf, flags);
shift             943 libavcodec/motion_est.c             d = cmp(s, x>>shift, y>>shift, x&mask, y&mask, 0, 16, 2, 0, cmpf, chroma_cmpf, flags);
shift             959 libavcodec/motion_est.c     const int shift= 1+s->quarter_sample;
shift            1018 libavcodec/motion_est.c             if(P_LEFT[0]       > (c->xmax<<shift)) P_LEFT[0]       = (c->xmax<<shift);
shift            1025 libavcodec/motion_est.c                 if(P_TOP[1]      > (c->ymax<<shift)) P_TOP[1]     = (c->ymax<<shift);
shift            1026 libavcodec/motion_est.c                 if(P_TOPRIGHT[0] < (c->xmin<<shift)) P_TOPRIGHT[0]= (c->xmin<<shift);
shift            1027 libavcodec/motion_est.c                 if(P_TOPRIGHT[1] > (c->ymax<<shift)) P_TOPRIGHT[1]= (c->ymax<<shift);
shift            1045 libavcodec/motion_est.c         dmin = ff_epzs_motion_search(s, &mx, &my, P, 0, 0, s->p_mv_table, (1<<16)>>shift, 0, 16);
shift            1072 libavcodec/motion_est.c             mx <<=shift;
shift            1073 libavcodec/motion_est.c             my <<=shift;
shift            1076 libavcodec/motion_est.c             h263_mv4_search(s, mx, my, shift);
shift            1098 libavcodec/motion_est.c             mx <<=shift;
shift            1099 libavcodec/motion_est.c             my <<=shift;
shift            1103 libavcodec/motion_est.c             if(h263_mv4_search(s, mx, my, shift) < INT_MAX)
shift            1124 libavcodec/motion_est.c             int dmin4= h263_mv4_search(s, mx, my, shift);
shift            1206 libavcodec/motion_est.c     const int shift= 1+s->quarter_sample;
shift            1221 libavcodec/motion_est.c     if(P_LEFT[0]       < (c->xmin<<shift)) P_LEFT[0]       = (c->xmin<<shift);
shift            1234 libavcodec/motion_est.c         if(P_TOP[1]      < (c->ymin<<shift)) P_TOP[1]     = (c->ymin<<shift);
shift            1235 libavcodec/motion_est.c         if(P_TOPRIGHT[0] > (c->xmax<<shift)) P_TOPRIGHT[0]= (c->xmax<<shift);
shift            1236 libavcodec/motion_est.c         if(P_TOPRIGHT[1] < (c->ymin<<shift)) P_TOPRIGHT[1]= (c->ymin<<shift);
shift            1245 libavcodec/motion_est.c     dmin = ff_epzs_motion_search(s, &mx, &my, P, 0, 0, s->p_mv_table, (1<<16)>>shift, 0, 16);
shift            1247 libavcodec/motion_est.c     s->p_mv_table[xy][0] = mx<<shift;
shift            1248 libavcodec/motion_est.c     s->p_mv_table[xy][1] = my<<shift;
shift            1259 libavcodec/motion_est.c     const int shift= 1+s->quarter_sample;
shift            1286 libavcodec/motion_est.c             if(P_LEFT[0]       > (c->xmax<<shift)) P_LEFT[0]       = (c->xmax<<shift);
shift            1294 libavcodec/motion_est.c                 if(P_TOP[1] > (c->ymax<<shift)) P_TOP[1]= (c->ymax<<shift);
shift            1295 libavcodec/motion_est.c                 if(P_TOPRIGHT[0] < (c->xmin<<shift)) P_TOPRIGHT[0]= (c->xmin<<shift);
shift            1296 libavcodec/motion_est.c                 if(P_TOPRIGHT[1] > (c->ymax<<shift)) P_TOPRIGHT[1]= (c->ymax<<shift);
shift            1306 libavcodec/motion_est.c             mv_scale= (s->pb_time<<16) / (s->pp_time<<shift);
shift            1308 libavcodec/motion_est.c             mv_scale= ((s->pb_time - s->pp_time)<<16) / (s->pp_time<<shift);
shift            1410 libavcodec/motion_est.c     const int shift= 1+qpel;
shift            1411 libavcodec/motion_est.c     const int xmin= c->xmin<<shift;
shift            1412 libavcodec/motion_est.c     const int ymin= c->ymin<<shift;
shift            1413 libavcodec/motion_est.c     const int xmax= c->xmax<<shift;
shift            1414 libavcodec/motion_est.c     const int ymax= c->ymax<<shift;
shift            1497 libavcodec/motion_est.c     const int shift= 1+s->quarter_sample;
shift            1505 libavcodec/motion_est.c     ymin= xmin=(-32)>>shift;
shift            1506 libavcodec/motion_est.c     ymax= xmax=   31>>shift;
shift            1520 libavcodec/motion_est.c         c->direct_basis_mv[i][0]= c->co_located_mv[i][0]*time_pb/time_pp + ((i& 1)<<(shift+3));
shift            1521 libavcodec/motion_est.c         c->direct_basis_mv[i][1]= c->co_located_mv[i][1]*time_pb/time_pp + ((i>>1)<<(shift+3));
shift            1525 libavcodec/motion_est.c         max= FFMAX(c->direct_basis_mv[i][0], c->direct_basis_mv[i][0] - c->co_located_mv[i][0])>>shift;
shift            1526 libavcodec/motion_est.c         min= FFMIN(c->direct_basis_mv[i][0], c->direct_basis_mv[i][0] - c->co_located_mv[i][0])>>shift;
shift            1532 libavcodec/motion_est.c         max= FFMAX(c->direct_basis_mv[i][1], c->direct_basis_mv[i][1] - c->co_located_mv[i][1])>>shift;
shift            1533 libavcodec/motion_est.c         min= FFMIN(c->direct_basis_mv[i][1], c->direct_basis_mv[i][1] - c->co_located_mv[i][1])>>shift;
shift            1560 libavcodec/motion_est.c     P_LEFT[0]        = av_clip(mv_table[mot_xy - 1][0], xmin<<shift, xmax<<shift);
shift            1561 libavcodec/motion_est.c     P_LEFT[1]        = av_clip(mv_table[mot_xy - 1][1], ymin<<shift, ymax<<shift);
shift            1565 libavcodec/motion_est.c         P_TOP[0]      = av_clip(mv_table[mot_xy - mot_stride             ][0], xmin<<shift, xmax<<shift);
shift            1566 libavcodec/motion_est.c         P_TOP[1]      = av_clip(mv_table[mot_xy - mot_stride             ][1], ymin<<shift, ymax<<shift);
shift            1567 libavcodec/motion_est.c         P_TOPRIGHT[0] = av_clip(mv_table[mot_xy - mot_stride + 1         ][0], xmin<<shift, xmax<<shift);
shift            1568 libavcodec/motion_est.c         P_TOPRIGHT[1] = av_clip(mv_table[mot_xy - mot_stride + 1         ][1], ymin<<shift, ymax<<shift);
shift            1574 libavcodec/motion_est.c     dmin = ff_epzs_motion_search(s, &mx, &my, P, 0, 0, mv_table, 1<<(16-shift), 0, 16);
shift             511 libavcodec/motion_est_template.c         d += (mv_penalty[((x)<<shift)-pred_x] + mv_penalty[((y)<<shift)-pred_y])*penalty_factor;\
shift             535 libavcodec/motion_est_template.c         d += (mv_penalty[((x)<<shift)-pred_x] + mv_penalty[((y)<<shift)-pred_y])*penalty_factor;\
shift             555 libavcodec/motion_est_template.c     const int shift= 1+qpel;\
shift             823 libavcodec/motion_est_template.c         d += (mv_penalty[((ax)<<shift)-pred_x] + mv_penalty[((ay)<<shift)-pred_y])*penalty_factor;\
shift             883 libavcodec/motion_est_template.c             minima[j].height+= (mv_penalty[((minima[j].x)<<shift)-pred_x] + mv_penalty[((minima[j].y)<<shift)-pred_y])*penalty_factor;
shift            1080 libavcodec/motion_est_template.c         CHECK_MV(P_LEFT[0]>>shift, P_LEFT[1]>>shift)
shift            1093 libavcodec/motion_est_template.c         CHECK_MV(    P_MEDIAN[0] >>shift ,    P_MEDIAN[1] >>shift)
shift            1094 libavcodec/motion_est_template.c         CHECK_CLIPPED_MV((P_MEDIAN[0]>>shift)  , (P_MEDIAN[1]>>shift)-1)
shift            1095 libavcodec/motion_est_template.c         CHECK_CLIPPED_MV((P_MEDIAN[0]>>shift)  , (P_MEDIAN[1]>>shift)+1)
shift            1096 libavcodec/motion_est_template.c         CHECK_CLIPPED_MV((P_MEDIAN[0]>>shift)-1, (P_MEDIAN[1]>>shift)  )
shift            1097 libavcodec/motion_est_template.c         CHECK_CLIPPED_MV((P_MEDIAN[0]>>shift)+1, (P_MEDIAN[1]>>shift)  )
shift            1100 libavcodec/motion_est_template.c         CHECK_MV(P_LEFT[0]    >>shift, P_LEFT[1]    >>shift)
shift            1101 libavcodec/motion_est_template.c         CHECK_MV(P_TOP[0]     >>shift, P_TOP[1]     >>shift)
shift            1102 libavcodec/motion_est_template.c         CHECK_MV(P_TOPRIGHT[0]>>shift, P_TOPRIGHT[1]>>shift)
shift            1196 libavcodec/motion_est_template.c         CHECK_MV(P_LEFT[0]>>shift, P_LEFT[1]>>shift)
shift            1199 libavcodec/motion_est_template.c         CHECK_MV(P_MV1[0]>>shift, P_MV1[1]>>shift)
shift            1201 libavcodec/motion_est_template.c         CHECK_MV(P_MV1[0]>>shift, P_MV1[1]>>shift)
shift            1203 libavcodec/motion_est_template.c         CHECK_MV(P_MEDIAN[0]>>shift, P_MEDIAN[1]>>shift)
shift            1204 libavcodec/motion_est_template.c         CHECK_MV(P_LEFT[0]>>shift, P_LEFT[1]>>shift)
shift            1205 libavcodec/motion_est_template.c         CHECK_MV(P_TOP[0]>>shift, P_TOP[1]>>shift)
shift            1206 libavcodec/motion_est_template.c         CHECK_MV(P_TOPRIGHT[0]>>shift, P_TOPRIGHT[1]>>shift)
shift            1256 libavcodec/motion_est_template.c         CHECK_MV(P_LEFT[0]>>shift, P_LEFT[1]>>shift)
shift            1259 libavcodec/motion_est_template.c         CHECK_MV(P_MV1[0]>>shift, P_MV1[1]>>shift)
shift            1261 libavcodec/motion_est_template.c         CHECK_MV(P_MV1[0]>>shift, P_MV1[1]>>shift)
shift            1263 libavcodec/motion_est_template.c         CHECK_MV(P_MEDIAN[0]>>shift, P_MEDIAN[1]>>shift)
shift            1264 libavcodec/motion_est_template.c         CHECK_MV(P_LEFT[0]>>shift, P_LEFT[1]>>shift)
shift            1265 libavcodec/motion_est_template.c         CHECK_MV(P_TOP[0]>>shift, P_TOP[1]>>shift)
shift            1266 libavcodec/motion_est_template.c         CHECK_MV(P_TOPRIGHT[0]>>shift, P_TOPRIGHT[1]>>shift)
shift             579 libavcodec/mpeg12.c     int code, sign, val, l, shift;
shift             590 libavcodec/mpeg12.c     shift = fcode - 1;
shift             592 libavcodec/mpeg12.c     if (shift) {
shift             593 libavcodec/mpeg12.c         val = (val - 1) << shift;
shift             594 libavcodec/mpeg12.c         val |= get_bits(&s->gb, shift);
shift             602 libavcodec/mpeg12.c     l= INT_BIT - 5 - shift;
shift             191 libavcodec/mpegaudiodec.c     int shift, mod;
shift             194 libavcodec/mpegaudiodec.c     shift = scale_factor_modshift[scale_factor];
shift             195 libavcodec/mpegaudiodec.c     mod = shift & 3;
shift             196 libavcodec/mpegaudiodec.c     shift >>= 2;
shift             198 libavcodec/mpegaudiodec.c     shift += n;
shift             200 libavcodec/mpegaudiodec.c     return (int)((val + (1LL << (shift - 1))) >> shift);
shift             205 libavcodec/mpegaudiodec.c     int shift, mod, val;
shift             207 libavcodec/mpegaudiodec.c     shift = scale_factor_modshift[scale_factor];
shift             208 libavcodec/mpegaudiodec.c     mod = shift & 3;
shift             209 libavcodec/mpegaudiodec.c     shift >>= 2;
shift             213 libavcodec/mpegaudiodec.c     if (shift > 0)
shift             214 libavcodec/mpegaudiodec.c         val = (val + (1 << (shift - 1))) >> shift;
shift             332 libavcodec/mpegaudiodec.c             int shift, mod;
shift             334 libavcodec/mpegaudiodec.c             shift = (i / 3);
shift             336 libavcodec/mpegaudiodec.c             scale_factor_modshift[i] = mod | (shift << 2);
shift            1396 libavcodec/mpegaudiodec.c     int len, i, j, k, l, v0, shift, gain, gains[3];
shift            1401 libavcodec/mpegaudiodec.c     shift = g->scalefac_scale + 1;
shift            1406 libavcodec/mpegaudiodec.c         v0 = gain - ((g->scale_factors[i] + pretab[i]) << shift) + 400;
shift            1421 libavcodec/mpegaudiodec.c                 v0 = gains[l] - (g->scale_factors[k++] << shift) + 400;
shift             705 libavcodec/mpegaudioenc.c                                 int q1, e, shift, mult;
shift             707 libavcodec/mpegaudioenc.c                                 shift = scale_factor_shift[e];
shift             711 libavcodec/mpegaudioenc.c                                 if (shift < 0)
shift             712 libavcodec/mpegaudioenc.c                                     q1 = sample << (-shift);
shift             714 libavcodec/mpegaudioenc.c                                     q1 = sample >> shift;
shift            1179 libavcodec/mpegvideo.c         const int shift= 1 + s->quarter_sample;
shift            1230 libavcodec/mpegvideo.c                         int mx= (pict->motion_val[direction][xy][0]>>shift) + sx;
shift            1231 libavcodec/mpegvideo.c                         int my= (pict->motion_val[direction][xy][1]>>shift) + sy;
shift            1240 libavcodec/mpegvideo.c                         int mx=(pict->motion_val[direction][xy][0]>>shift);
shift            1241 libavcodec/mpegvideo.c                         int my=(pict->motion_val[direction][xy][1]>>shift);
shift            1254 libavcodec/mpegvideo.c                         int mx=(pict->motion_val[direction][xy][0]>>shift);
shift            1255 libavcodec/mpegvideo.c                         int my=(pict->motion_val[direction][xy][1]>>shift);
shift            1266 libavcodec/mpegvideo.c                       int mx= (pict->motion_val[direction][xy][0]>>shift) + sx;
shift            1267 libavcodec/mpegvideo.c                       int my= (pict->motion_val[direction][xy][1]>>shift) + sy;
shift             617 libavcodec/mpegvideo_common.h     const int shift = s->quarter_sample ? 2 : 1;
shift             618 libavcodec/mpegvideo_common.h     const int mx= (s->mv[dir][0][0]>>shift) + 16*s->mb_x + 8;
shift             619 libavcodec/mpegvideo_common.h     const int my= (s->mv[dir][0][1]>>shift) + 16*s->mb_y;
shift              60 libavcodec/mpegvideo_enc.c     int shift=0;
shift             120 libavcodec/mpegvideo_enc.c             while(((max * qmat[qscale][i]) >> shift) > INT_MAX){
shift             121 libavcodec/mpegvideo_enc.c                 shift++;
shift             125 libavcodec/mpegvideo_enc.c     if(shift){
shift             126 libavcodec/mpegvideo_enc.c         av_log(NULL, AV_LOG_INFO, "Warning, QMAT_SHIFT is larger than %d, overflows possible\n", QMAT_SHIFT - shift);
shift            1403 libavcodec/msmpeg4.c     int code, val, sign, shift;
shift            1413 libavcodec/msmpeg4.c     shift = f_code - 1;
shift            1415 libavcodec/msmpeg4.c     if (shift) {
shift            1416 libavcodec/msmpeg4.c         val = (val - 1) << shift;
shift            1417 libavcodec/msmpeg4.c         val |= get_bits(&s->gb, shift);
shift              89 libavcodec/nellymoser.c     if (shift > 0)
shift              90 libavcodec/nellymoser.c         return i << shift;
shift              91 libavcodec/nellymoser.c     return i >> -shift;
shift             100 libavcodec/nellymoser.c         b = ((b>>(shift-1))+1)>>1;
shift             124 libavcodec/nellymoser.c     short shift, shift_saved;
shift             133 libavcodec/nellymoser.c     shift = -16;
shift             134 libavcodec/nellymoser.c     shift += headroom(&max);
shift             138 libavcodec/nellymoser.c         sbuf[i] = signed_shift(buf[i], shift);
shift             143 libavcodec/nellymoser.c     shift += 11;
shift             144 libavcodec/nellymoser.c     shift_saved = shift;
shift             145 libavcodec/nellymoser.c     sum -= NELLY_DETAIL_BITS << shift;
shift             146 libavcodec/nellymoser.c     shift += headroom(&sum);
shift             148 libavcodec/nellymoser.c     shift = shift_saved - (NELLY_BASE_SHIFT+shift-31);
shift             150 libavcodec/nellymoser.c     small_off = signed_shift(small_off, shift);
shift             157 libavcodec/nellymoser.c         for(shift=0; FFABS(off) <= 16383; shift++)
shift             161 libavcodec/nellymoser.c         shift = shift_saved-(NELLY_BASE_SHIFT+shift-15);
shift             163 libavcodec/nellymoser.c         off = signed_shift(off, shift);
shift             149 libavcodec/pcm.c         register type v = (*samples_##type++ >> shift) + offset; \
shift             320 libavcodec/pcm.c         *dst_##type++ = (v - offset) << shift; \
shift              30 libavcodec/pixdesc.h     uint16_t shift        :3;            ///< number of lsb that must be shifted away to get the value
shift              76 libavcodec/pixdesc.h     int shift= comp.shift;
shift              87 libavcodec/pixdesc.h         val = (val>>shift) & mask;
shift              91 libavcodec/pixdesc.h             shift-=depth;
shift              92 libavcodec/pixdesc.h             while(shift<0){
shift              93 libavcodec/pixdesc.h                 shift+=8;
shift              75 libavcodec/png.c     int shift, xmin, pass_width;
shift              80 libavcodec/png.c     shift = ff_png_pass_xshift[pass];
shift              81 libavcodec/png.c     pass_width = (width - xmin + (1 << shift) - 1) >> shift;
shift              87 libavcodec/ppc/idct_altivec.c     vec_u16 shift;                                                 \
shift              98 libavcodec/ppc/idct_altivec.c     shift = vec_splat_u16 (4);                                          \
shift             100 libavcodec/ppc/idct_altivec.c     vx0 = vec_mradds (vec_sl (block[0], shift), constants[1], zero);    \
shift             101 libavcodec/ppc/idct_altivec.c     vx1 = vec_mradds (vec_sl (block[1], shift), constants[2], zero);    \
shift             102 libavcodec/ppc/idct_altivec.c     vx2 = vec_mradds (vec_sl (block[2], shift), constants[3], zero);    \
shift             103 libavcodec/ppc/idct_altivec.c     vx3 = vec_mradds (vec_sl (block[3], shift), constants[4], zero);    \
shift             104 libavcodec/ppc/idct_altivec.c     vx4 = vec_mradds (vec_sl (block[4], shift), constants[1], zero);    \
shift             105 libavcodec/ppc/idct_altivec.c     vx5 = vec_mradds (vec_sl (block[5], shift), constants[4], zero);    \
shift             106 libavcodec/ppc/idct_altivec.c     vx6 = vec_mradds (vec_sl (block[6], shift), constants[3], zero);    \
shift             107 libavcodec/ppc/idct_altivec.c     vx7 = vec_mradds (vec_sl (block[7], shift), constants[2], zero);    \
shift             140 libavcodec/ppc/idct_altivec.c     shift = vec_splat_u16 (6);                                          \
shift             141 libavcodec/ppc/idct_altivec.c     vx0 = vec_sra (vy0, shift);                                         \
shift             142 libavcodec/ppc/idct_altivec.c     vx1 = vec_sra (vy1, shift);                                         \
shift             143 libavcodec/ppc/idct_altivec.c     vx2 = vec_sra (vy2, shift);                                         \
shift             144 libavcodec/ppc/idct_altivec.c     vx3 = vec_sra (vy3, shift);                                         \
shift             145 libavcodec/ppc/idct_altivec.c     vx4 = vec_sra (vy4, shift);                                         \
shift             146 libavcodec/ppc/idct_altivec.c     vx5 = vec_sra (vy5, shift);                                         \
shift             147 libavcodec/ppc/idct_altivec.c     vx6 = vec_sra (vy6, shift);                                         \
shift             148 libavcodec/ppc/idct_altivec.c     vx7 = vec_sra (vy7, shift);
shift             117 libavcodec/ppc/int_altivec.c     if(shift & 0x10) shifts = vec_add(shifts, vec_sl(vec_splat_u32(0x08), vec_splat_u32(0x1)));
shift             118 libavcodec/ppc/int_altivec.c     if(shift & 0x08) shifts = vec_add(shifts, vec_splat_u32(0x08));
shift             119 libavcodec/ppc/int_altivec.c     if(shift & 0x04) shifts = vec_add(shifts, vec_splat_u32(0x04));
shift             120 libavcodec/ppc/int_altivec.c     if(shift & 0x02) shifts = vec_add(shifts, vec_splat_u32(0x02));
shift             121 libavcodec/ppc/int_altivec.c     if(shift & 0x01) shifts = vec_add(shifts, vec_splat_u32(0x01));
shift             364 libavcodec/sh4/qpel.c     const int s= 1<<shift;
shift             381 libavcodec/sh4/qpel.c             src_x>>=shift;
shift             382 libavcodec/sh4/qpel.c             src_y>>=shift;
shift             391 libavcodec/sh4/qpel.c                                         + r)>>(shift*2);
shift             396 libavcodec/sh4/qpel.c                                         + r)>>(shift*2);
shift             403 libavcodec/sh4/qpel.c                                         + r)>>(shift*2);
shift             731 libavcodec/snow.c         dst[0] = LIFT(src[0], ((mul*2*ref[0]+add)>>shift), inverse);
shift             739 libavcodec/snow.c                  ((mul*(ref[i*ref_step] + ref[(i+1)*ref_step])+add)>>shift),
shift             746 libavcodec/snow.c                  ((mul*2*ref[w*ref_step]+add)>>shift),
shift             763 libavcodec/snow.c         dst[0] = LIFT(src[0], ((mul*2*ref[0]+add)>>shift), inverse);
shift             771 libavcodec/snow.c                  ((mul*(ref[i*ref_step] + ref[(i+1)*ref_step])+add)>>shift),
shift             778 libavcodec/snow.c                  ((mul*2*ref[w*ref_step]+add)>>shift),
shift             794 libavcodec/snow.c     assert(shift == 4);
shift             797 libavcodec/snow.c             (src) + (((ref) + 4*(src))>>shift): \
shift             827 libavcodec/snow.c     assert(shift == 4);
shift             830 libavcodec/snow.c         (src) + (((ref) + 4*(src))>>shift): \
shift            1773 libavcodec/snow.c     const int shift= 1+qpel;
shift            1821 libavcodec/snow.c     if(P_LEFT[0]     > (c->xmax<<shift)) P_LEFT[0]    = (c->xmax<<shift);
shift            1822 libavcodec/snow.c     if(P_LEFT[1]     > (c->ymax<<shift)) P_LEFT[1]    = (c->ymax<<shift);
shift            1823 libavcodec/snow.c     if(P_TOP[0]      > (c->xmax<<shift)) P_TOP[0]     = (c->xmax<<shift);
shift            1824 libavcodec/snow.c     if(P_TOP[1]      > (c->ymax<<shift)) P_TOP[1]     = (c->ymax<<shift);
shift            1825 libavcodec/snow.c     if(P_TOPRIGHT[0] < (c->xmin<<shift)) P_TOPRIGHT[0]= (c->xmin<<shift);
shift            1826 libavcodec/snow.c     if(P_TOPRIGHT[0] > (c->xmax<<shift)) P_TOPRIGHT[0]= (c->xmax<<shift); //due to pmx no clip
shift            1827 libavcodec/snow.c     if(P_TOPRIGHT[1] > (c->ymax<<shift)) P_TOPRIGHT[1]= (c->ymax<<shift);
shift            1846 libavcodec/snow.c                                          (1<<16)>>shift, level-LOG2_MB_SIZE+4, block_w);
shift            4175 libavcodec/snow.c         int shift= !!i;
shift            4176 libavcodec/snow.c         for(y=0; y<(height>>shift); y++)
shift            4179 libavcodec/snow.c                    width>>shift);
shift             156 libavcodec/snow.h         dst[i] = src[i] - ((mul * (ref[i] + ref[i + 1]) + add) >> shift);
shift             160 libavcodec/snow.h         dst[w] = src[w] - ((mul * 2 * ref[w] + add) >> shift);
shift             653 libavcodec/sonic.c                 s->int_samples[i+1] -= shift(s->int_samples[i], 1);
shift             909 libavcodec/sonic.c                 s->int_samples[i+1] += shift(s->int_samples[i], 1);
shift             925 libavcodec/sonic.c             s->int_samples[i] = shift(s->int_samples[i], SAMPLE_SHIFT);
shift              84 libavcodec/tta.c     int32_t shift, round, error, mode;
shift              99 libavcodec/tta.c     c->shift = shift;
shift             100 libavcodec/tta.c    c->round = shift_1[shift-1];
shift             160 libavcodec/tta.c         *in -= (sum >> c->shift);
shift             164 libavcodec/tta.c         *in += (sum >> c->shift);
shift            1202 libavcodec/vc1.c             int scale, shift, i;
shift            1210 libavcodec/vc1.c                 shift = (255 - v->lumshift * 2) << 6;
shift            1212 libavcodec/vc1.c                     shift += 128 << 6;
shift            1216 libavcodec/vc1.c                     shift = (v->lumshift - 64) << 6;
shift            1218 libavcodec/vc1.c                     shift = v->lumshift << 6;
shift            1221 libavcodec/vc1.c                 v->luty[i] = av_clip_uint8((scale * i + shift + 32) >> 6);
shift            1448 libavcodec/vc1.c             int scale, shift, i;
shift            1455 libavcodec/vc1.c                 shift = (255 - v->lumshift * 2) << 6;
shift            1457 libavcodec/vc1.c                     shift += 128 << 6;
shift            1461 libavcodec/vc1.c                     shift = (v->lumshift - 64) << 6;
shift            1463 libavcodec/vc1.c                     shift = v->lumshift << 6;
shift            1466 libavcodec/vc1.c                 v->luty[i] = av_clip_uint8((scale * i + shift + 32) >> 6);
shift             360 libavcodec/vc1dsp.c             int              shift = (shift_value[hmode]+shift_value[vmode])>>1;
shift             363 libavcodec/vc1dsp.c             r = (1<<(shift-1)) + rnd-1;
shift             368 libavcodec/vc1dsp.c                     tptr[i] = (vc1_mspel_ver_filter_16bits(src + i, stride, vmode)+r)>>shift;
shift              93 libavcodec/wavpack.c     int and, or, shift;
shift             408 libavcodec/wavpack.c         *dst++ = ((L + bit) << s->shift) - bit;
shift             410 libavcodec/wavpack.c         *dst++ = ((R + bit) << s->shift) - bit;
shift             454 libavcodec/wavpack.c         *dst++ = ((S + bit) << s->shift) - bit;
shift             496 libavcodec/wavpack.c     s->and = s->or = s->shift = 0;
shift             654 libavcodec/wavpack.c                 s->shift = buf[1];
shift             657 libavcodec/wavpack.c                 s->shift = buf[2];
shift             660 libavcodec/wavpack.c                 s->shift = buf[3];
shift              35 libavcodec/wnv1.c     int shift;
shift              54 libavcodec/wnv1.c         return ff_reverse[ get_bits(&w->gb, 8 - w->shift) ];
shift              56 libavcodec/wnv1.c         return base_value + ((v - 7)<<w->shift);
shift              92 libavcodec/wnv1.c         l->shift = 2;
shift              94 libavcodec/wnv1.c         l->shift = 8 - (buf[2] >> 4);
shift              95 libavcodec/wnv1.c         if (l->shift > 4) {
shift              97 libavcodec/wnv1.c             l->shift = 4;
shift              99 libavcodec/wnv1.c         if (l->shift < 1) {
shift             101 libavcodec/wnv1.c             l->shift = 1;
shift            1645 libavcodec/x86/dsputil_mmx.c     const int ix = ox>>(16+shift);
shift            1646 libavcodec/x86/dsputil_mmx.c     const int iy = oy>>(16+shift);
shift            1656 libavcodec/x86/dsputil_mmx.c     const uint64_t shift2 = 2*shift;
shift            1660 libavcodec/x86/dsputil_mmx.c     const int dxw = (dxx-(1<<(16+shift)))*(w-1);
shift            1661 libavcodec/x86/dsputil_mmx.c     const int dyh = (dyy-(1<<(16+shift)))*(h-1);
shift            1666 libavcodec/x86/dsputil_mmx.c          (oy^(oy+dyw)) | (oy^(oy+dyh)) | (oy^(oy+dyw+dyh))) >> (16+shift)
shift            1671 libavcodec/x86/dsputil_mmx.c         ff_gmc_c(dst, src, stride, h, ox, oy, dxx, dxy, dyx, dyy, shift, r, width, height);
shift            1688 libavcodec/x86/dsputil_mmx.c         :: "r"(1<<shift)
shift            2537 libavcodec/x86/dsputil_mmx.c     sh.a = shift;
shift              34 libavcodec/x86/mathops.h             : "a" ((int)ra), "rm" ((int)rb), "i"(shift));\
shift             252 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm7       \n\t"\
shift             253 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm4       \n\t"\
shift             257 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm1       \n\t"\
shift             258 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm2       \n\t"\
shift             274 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm2       \n\t"\
shift             275 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm0       \n\t"\
shift             280 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm6       \n\t"\
shift             283 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm4       \n\t"\
shift             318 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm7       \n\t"\
shift             319 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm4       \n\t"\
shift             323 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm0       \n\t"\
shift             324 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm2       \n\t"\
shift             344 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm2       \n\t"\
shift             345 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm5       \n\t"\
shift             350 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm6       \n\t"\
shift             351 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm4       \n\t"\
shift             404 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm7       \n\t"\
shift             405 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm4       \n\t"\
shift             409 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm1       \n\t"\
shift             410 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm2       \n\t"\
shift             426 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm2       \n\t"\
shift             427 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm0       \n\t"\
shift             432 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm6       \n\t"\
shift             435 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm4       \n\t"\
shift             512 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm7       \n\t"\
shift             513 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm4       \n\t"\
shift             517 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm1       \n\t"\
shift             518 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm2       \n\t"\
shift             534 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm2       \n\t"\
shift             535 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm0       \n\t"\
shift             540 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm6       \n\t"\
shift             543 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm4       \n\t"\
shift             599 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm7       \n\t"\
shift             600 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm4       \n\t"\
shift             604 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm1       \n\t"\
shift             605 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm2       \n\t"\
shift             621 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm2       \n\t"\
shift             622 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm0       \n\t"\
shift             627 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm6       \n\t"\
shift             630 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm4       \n\t"\
shift             667 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm7       \n\t"\
shift             668 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm4       \n\t"\
shift             672 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm1       \n\t"\
shift             673 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm2       \n\t"\
shift             689 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm2       \n\t"\
shift             690 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm0       \n\t"\
shift             695 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm6       \n\t"\
shift             698 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm4       \n\t"\
shift             740 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm7       \n\t"\
shift             741 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm4       \n\t"\
shift             745 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm0       \n\t"\
shift             746 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm2       \n\t"\
shift             766 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm2       \n\t"\
shift             767 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm5       \n\t"\
shift             772 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm6       \n\t"\
shift             773 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm4       \n\t"\
shift             822 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm1       \n\t"\
shift             823 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm4       \n\t"\
shift             827 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm0       \n\t"\
shift             828 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm2       \n\t"\
shift             843 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm2       \n\t"\
shift             844 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm5       \n\t"\
shift             848 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm6       \n\t"\
shift             849 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm1       \n\t"\
shift             887 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm1       \n\t"\
shift             888 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm4       \n\t"\
shift             892 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm0       \n\t"\
shift             893 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm2       \n\t"\
shift             908 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm2       \n\t"\
shift             909 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm5       \n\t"\
shift             913 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm6       \n\t"\
shift             914 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm1       \n\t"\
shift             959 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm7       \n\t"\
shift             960 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm4       \n\t"\
shift             964 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm0       \n\t"\
shift             965 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm2       \n\t"\
shift             985 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm2       \n\t"\
shift             986 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm5       \n\t"\
shift             991 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm6       \n\t"\
shift             992 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm4       \n\t"\
shift            1028 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm7       \n\t"\
shift            1029 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm4       \n\t"\
shift            1033 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm0       \n\t"\
shift            1034 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm1       \n\t"\
shift            1049 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm1       \n\t"\
shift            1050 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm5       \n\t"\
shift            1054 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm6       \n\t"\
shift            1055 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm4       \n\t"\
shift            1108 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm4       \n\t"\
shift            1109 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm7       \n\t"\
shift            1110 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm3       \n\t"\
shift            1113 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm0       \n\t"\
shift            1118 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm5       \n\t"\
shift            1119 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm6       \n\t"\
shift            1120 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm2       \n\t"\
shift            1123 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm1       \n\t"\
shift            1166 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm7       \n\t"\
shift            1167 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm4       \n\t"\
shift            1171 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm0       \n\t"\
shift            1172 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm3       \n\t"\
shift            1187 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm3       \n\t"\
shift            1188 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm5       \n\t"\
shift            1192 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm6       \n\t"\
shift            1195 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm4       \n\t"\
shift            1221 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm4       \n\t"\
shift            1222 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm0       \n\t"\
shift            1229 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm1       \n\t"\
shift            1232 libavcodec/x86/simple_idct_mmx.c         "psrad $" #shift ", %%mm2       \n\t"\
shift             101 libavcodec/x86/vc1dsp_mmx.c           "m"(shift), "m"(rnd), "r"(9*stride-4)
shift             263 libavcodec/x86/vc1dsp_mmx.c                                  int rnd, int64_t shift)                \
shift             303 libavcodec/x86/vc1dsp_mmx.c           "m"(rnd), "m"(shift)                                          \
shift             423 libavcodec/x86/vc1dsp_mmx.c             int              shift = (shift_value[hmode]+shift_value[vmode])>>1;
shift             427 libavcodec/x86/vc1dsp_mmx.c             r = (1<<(shift-1)) + rnd-1;
shift             428 libavcodec/x86/vc1dsp_mmx.c             vc1_put_shift_ver_16bits[vmode](tmp, src-1, stride, r, shift);
shift              51 libavformat/dv.c     uint16_t shift, result;
shift              54 libavformat/dv.c     shift  = (sample & 0xf00) >> 8;
shift              56 libavformat/dv.c     if (shift < 0x2 || shift > 0xd) {
shift              58 libavformat/dv.c     } else if (shift < 0x8) {
shift              59 libavformat/dv.c         shift--;
shift              60 libavformat/dv.c         result = (sample - (256 * shift)) << shift;
shift              62 libavformat/dv.c         shift = 0xe - shift;
shift              63 libavformat/dv.c         result = ((sample + ((256 * shift) + 1)) << shift) - 1;
shift             261 libavutil/common.h         int bytes, shift;\
shift             268 libavutil/common.h             shift = (bytes - 1) * 6;\
shift             269 libavutil/common.h             tmp = (256 - (256 >> bytes)) | (in >> shift);\
shift             271 libavutil/common.h             while (shift >= 6) {\
shift             272 libavutil/common.h                 shift -= 6;\
shift             273 libavutil/common.h                 tmp = 0x80 | ((in >> shift) & 0x3f);\
shift            1404 libswscale/swscale.c             int shift= (*filterPos)[i] + filterSize - srcW;
shift            1408 libswscale/swscale.c                 int right= FFMIN(j + shift, filterSize-1);
shift            1575 libswscale/swscale.c                 int shift=0;
shift            1584 libswscale/swscale.c                 if (i+3>=dstW) shift=maxShift; //avoid overread
shift            1585 libswscale/swscale.c                 else if ((filterPos[i/2]&3) <= maxShift) shift=filterPos[i/2]&3; //Align
shift            1587 libswscale/swscale.c                 if (shift && i>=shift)
shift            1589 libswscale/swscale.c                     funnyCode[fragmentPos + imm8OfPShufW1B]+= 0x55*shift;
shift            1590 libswscale/swscale.c                     funnyCode[fragmentPos + imm8OfPShufW2B]+= 0x55*shift;
shift            1591 libswscale/swscale.c                     filterPos[i/2]-=shift;
shift            1599 libswscale/swscale.c                 int shift=0;
shift            1607 libswscale/swscale.c                 if (i+4>=dstW) shift=maxShift; //avoid overread
shift            1608 libswscale/swscale.c                 else if ((filterPos[i/2]&3) <= maxShift) shift=filterPos[i/2]&3; //partial align
shift            1610 libswscale/swscale.c                 if (shift && i>=shift)
shift            1612 libswscale/swscale.c                     funnyCode[fragmentPos + imm8OfPShufW1A]+= 0x55*shift;
shift            1613 libswscale/swscale.c                     funnyCode[fragmentPos + imm8OfPShufW2A]+= 0x55*shift;
shift            1614 libswscale/swscale.c                     filterPos[i/2]-=shift;
shift            3006 libswscale/swscale.c     int length= a->length + FFABS(shift)*2;
shift            3018 libswscale/swscale.c         coeff[i + (length-1)/2 - (a->length-1)/2 - shift]= a->coeff[i];
shift            3025 libswscale/swscale.c     SwsVector *shifted= sws_getShiftedVec(a, shift);
shift             112 tests/tiny_psnr.c     int shift= argc<5 ? 0 : atoi(argv[4]);
shift             130 tests/tiny_psnr.c     fseek(f[shift<0], shift < 0 ? -shift : shift, SEEK_SET);