/third_party/skia/third_party/externals/libjpeg-turbo/ |
H A D | jccoefct.c | 73 my_coef_ptr coef = (my_coef_ptr)cinfo->coef; variable 80 coef->MCU_rows_per_iMCU_row = 1; 82 if (coef->iMCU_row_num < (cinfo->total_iMCU_rows - 1)) 83 coef->MCU_rows_per_iMCU_row = cinfo->cur_comp_info[0]->v_samp_factor; 85 coef->MCU_rows_per_iMCU_row = cinfo->cur_comp_info[0]->last_row_height; 88 coef->mcu_ctr = 0; 89 coef->MCU_vert_offset = 0; 100 my_coef_ptr coef = (my_coef_ptr)cinfo->coef; in start_pass_coef() local 143 my_coef_ptr coef = (my_coef_ptr)cinfo->coef; METHODDEF() local 247 my_coef_ptr coef = (my_coef_ptr)cinfo->coef; METHODDEF() local 343 my_coef_ptr coef = (my_coef_ptr)cinfo->coef; METHODDEF() local 407 my_coef_ptr coef; jinit_c_coef_controller() local [all...] |
H A D | jctrans.c | 243 my_coef_ptr coef = (my_coef_ptr)cinfo->coef; in start_iMCU_row() local 250 coef->MCU_rows_per_iMCU_row = 1; in start_iMCU_row() 252 if (coef->iMCU_row_num < (cinfo->total_iMCU_rows - 1)) in start_iMCU_row() 253 coef->MCU_rows_per_iMCU_row = cinfo->cur_comp_info[0]->v_samp_factor; in start_iMCU_row() 255 coef->MCU_rows_per_iMCU_row = cinfo->cur_comp_info[0]->last_row_height; in start_iMCU_row() 258 coef->mcu_ctr = 0; in start_iMCU_row() 259 coef->MCU_vert_offset = 0; in start_iMCU_row() 270 my_coef_ptr coef = (my_coef_ptr)cinfo->coef; in start_pass_coef() local 293 my_coef_ptr coef = (my_coef_ptr)cinfo->coef; METHODDEF() local 379 my_coef_ptr coef; transencode_coef_controller() local [all...] |
H A D | jdcoefct.c | 60 my_coef_ptr coef = (my_coef_ptr)cinfo->coef; in start_output_pass() local 63 if (coef->pub.coef_arrays != NULL) { in start_output_pass() 65 coef->pub.decompress_data = decompress_smooth_data; in start_output_pass() 67 coef->pub.decompress_data = decompress_data; in start_output_pass() 87 my_coef_ptr coef = (my_coef_ptr)cinfo->coef; in decompress_onepass() local 98 for (yoffset = coef->MCU_vert_offset; yoffset < coef->MCU_rows_per_iMCU_row; in decompress_onepass() 100 for (MCU_col_num = coef in decompress_onepass() 194 my_coef_ptr coef = (my_coef_ptr)cinfo->coef; consume_data() local 267 my_coef_ptr coef = (my_coef_ptr)cinfo->coef; decompress_data() local 361 my_coef_ptr coef = (my_coef_ptr)cinfo->coef; LOCAL() local 430 my_coef_ptr coef = (my_coef_ptr)cinfo->coef; decompress_smooth_data() local 815 my_coef_ptr coef; jinit_d_coef_controller() local [all...] |
H A D | jdcoefct.h | 66 my_coef_ptr coef = (my_coef_ptr)cinfo->coef; in start_iMCU_row() local 73 coef->MCU_rows_per_iMCU_row = 1; in start_iMCU_row() 76 coef->MCU_rows_per_iMCU_row = cinfo->cur_comp_info[0]->v_samp_factor; in start_iMCU_row() 78 coef->MCU_rows_per_iMCU_row = cinfo->cur_comp_info[0]->last_row_height; in start_iMCU_row() 81 coef->MCU_ctr = 0; in start_iMCU_row() 82 coef->MCU_vert_offset = 0; in start_iMCU_row()
|
H A D | jidctfst.c | 132 #define DEQUANTIZE(coef, quantval) (((IFAST_MULT_TYPE)(coef)) * (quantval)) 134 #define DEQUANTIZE(coef, quantval) \ 135 DESCALE((coef) * (quantval), IFAST_SCALE_BITS - PASS1_BITS)
|
/third_party/ffmpeg/tests/checkasm/ |
H A D | vp8dsp.c | 34 #define randomize_buffers(src, dst, stride, coef) \ 41 (coef)[y * 4 + x] = (src)[y * (stride) + x] - \ 46 static void dct4x4(int16_t *coef) in dct4x4() argument 50 const int a1 = (coef[i*4 + 0] + coef[i*4 + 3]) * 8; in dct4x4() 51 const int b1 = (coef[i*4 + 1] + coef[i*4 + 2]) * 8; in dct4x4() 52 const int c1 = (coef[i*4 + 1] - coef[i*4 + 2]) * 8; in dct4x4() 53 const int d1 = (coef[ in dct4x4() 71 wht4x4(int16_t *coef) wht4x4() argument [all...] |
H A D | h264dsp.c | 50 coef[y * sz + x] = src[y * PIXEL_STRIDE + x] - \ 53 ((int32_t *)coef)[y * sz + x] = \ 62 static void dct4x4_##size(dctcoef *coef) \ 67 const int z0 = coef[i*4 + 0] + coef[i*4 + 3]; \ 68 const int z1 = coef[i*4 + 1] + coef[i*4 + 2]; \ 69 const int z2 = coef[i*4 + 0] - coef[i*4 + 3]; \ 70 const int z3 = coef[ 158 dct4x4(int16_t *coef, int bit_depth) dct4x4() argument 166 dct8x8(int16_t *coef, int bit_depth) dct8x8() argument 273 int16_t coef[8 * 8 * 2]; check_idct_multiple() local [all...] |
/third_party/ffmpeg/libavfilter/ |
H A D | vf_w3fdif.c | 104 const int16_t *coef, int linesize) in filter_simple_low() 109 *work_line = *in_lines_cur[0]++ * coef[0]; in filter_simple_low() 110 *work_line++ += *in_lines_cur[1]++ * coef[1]; in filter_simple_low() 116 const int16_t *coef, int linesize) in filter_complex_low() 121 *work_line = *in_lines_cur[0]++ * coef[0]; in filter_complex_low() 122 *work_line += *in_lines_cur[1]++ * coef[1]; in filter_complex_low() 123 *work_line += *in_lines_cur[2]++ * coef[2]; in filter_complex_low() 124 *work_line++ += *in_lines_cur[3]++ * coef[3]; in filter_complex_low() 131 const int16_t *coef, int linesize) in filter_simple_high() 136 *work_line += *in_lines_cur[0]++ * coef[ in filter_simple_high() 102 filter_simple_low(int32_t *work_line, uint8_t *in_lines_cur[2], const int16_t *coef, int linesize) filter_simple_low() argument 114 filter_complex_low(int32_t *work_line, uint8_t *in_lines_cur[4], const int16_t *coef, int linesize) filter_complex_low() argument 128 filter_simple_high(int32_t *work_line, uint8_t *in_lines_cur[3], uint8_t *in_lines_adj[3], const int16_t *coef, int linesize) filter_simple_high() argument 145 filter_complex_high(int32_t *work_line, uint8_t *in_lines_cur[5], uint8_t *in_lines_adj[5], const int16_t *coef, int linesize) filter_complex_high() argument 174 filter16_simple_low(int32_t *work_line, uint8_t *in_lines_cur8[2], const int16_t *coef, int linesize) filter16_simple_low() argument 188 filter16_complex_low(int32_t *work_line, uint8_t *in_lines_cur8[4], const int16_t *coef, int linesize) filter16_complex_low() argument 207 filter16_simple_high(int32_t *work_line, uint8_t *in_lines_cur8[3], uint8_t *in_lines_adj8[3], const int16_t *coef, int linesize) filter16_simple_high() argument 231 filter16_complex_high(int32_t *work_line, uint8_t *in_lines_cur8[5], uint8_t *in_lines_adj8[5], const int16_t *coef, int linesize) filter16_complex_high() argument [all...] |
H A D | w3fdif.h | 30 const int16_t *coef, int linesize); 33 const int16_t *coef, int linesize); 37 const int16_t *coef, int linesize); 41 const int16_t *coef, int linesize);
|
/third_party/mesa3d/src/gallium/drivers/softpipe/ |
H A D | sp_setup.c | 101 struct tgsi_interp_coef coef[PIPE_MAX_SHADER_INPUTS]; member 401 * The result will be put into setup->coef[slot].a0[i]. 407 struct tgsi_interp_coef *coef, in const_coeff() 412 coef->dadx[i] = 0; in const_coeff() 413 coef->dady[i] = 0; in const_coeff() 417 coef->a0[i] = setup->vprovoke[vertSlot][i]; in const_coeff() 428 struct tgsi_interp_coef *coef, in tri_linear_coeff() 441 coef->dadx[i] = dadx; in tri_linear_coeff() 442 coef->dady[i] = dady; in tri_linear_coeff() 456 coef in tri_linear_coeff() 406 const_coeff(struct setup_context *setup, struct tgsi_interp_coef *coef, uint vertSlot, uint i) const_coeff() argument 427 tri_linear_coeff(struct setup_context *setup, struct tgsi_interp_coef *coef, uint i, const float v[3]) tri_linear_coeff() argument 472 tri_persp_coeff(struct setup_context *setup, struct tgsi_interp_coef *coef, uint i, const float v[3]) tri_persp_coeff() argument 835 line_linear_coeff(const struct setup_context *setup, struct tgsi_interp_coef *coef, uint i, const float v[2]) line_linear_coeff() argument 857 line_persp_coeff(const struct setup_context *setup, struct tgsi_interp_coef *coef, uint i, const float v[2]) line_persp_coeff() argument 1124 point_persp_coeff(const struct setup_context *setup, const float (*vert)[4], struct tgsi_interp_coef *coef, uint vertSlot, uint i) point_persp_coeff() argument [all...] |
H A D | sp_fs_exec.c | 77 setup_pos_vector(const struct tgsi_interp_coef *coef, in setup_pos_vector() argument 96 const float dadx = coef->dadx[chan]; in setup_pos_vector() 97 const float dady = coef->dady[chan]; in setup_pos_vector() 98 const float a0 = coef->a0[chan] + dadx * x + dady * y; in setup_pos_vector()
|
/third_party/ffmpeg/libavfilter/x86/ |
H A D | vf_w3fdif_init.c | 29 const int16_t *coef, int linesize); 34 const int16_t *coef, int linesize); 38 const int16_t *coef, int linesize); 43 const int16_t *coef, int linesize);
|
/third_party/ffmpeg/libavcodec/ |
H A D | aacenc_tns.c | 48 static inline int compress_coeffs(int *coef, int order, int c_bits) in compress_coeffs() argument 58 if (coef[i] >= low_idx && coef[i] <= high_idx) in compress_coeffs() 61 coef[i] -= (coef[i] > high_idx) ? shift_val : 0; in compress_coeffs() 120 compute_lpc_coefs(tns->coef[w][filt], order, lpc, 0, 0, 0); in ff_aac_apply_tns() 147 static inline void quantize_coefs(double *coef, int *idx, float *lpc, int order, in quantize_coefs() argument 153 idx[i] = quant_array_idx(coef[i], quant_arr, c_bits ? 16 : 8); in quantize_coefs() 207 quantize_coefs(&coefs[oc_start], tns->coef_idx[w][g], tns->coef[w][g], in ff_aac_search_for_tns()
|
H A D | aacdec_fixed.c | 155 int i, coef; in vector_pow43() local 158 coef = coefs[i]; in vector_pow43() 159 if (coef < 0) in vector_pow43() 160 coef = -(int)ff_cbrt_tab_fixed[(-coef) & 8191]; in vector_pow43() 162 coef = (int)ff_cbrt_tab_fixed[ coef & 8191]; in vector_pow43() 163 coefs[i] = coef; in vector_pow43() 281 static av_always_inline void predict(PredictorState *ps, int *coef, in predict() argument 317 *coef in predict() [all...] |
H A D | aacenc_utils.h | 59 static inline int quant(float coef, const float Q, const float rounding) in quant() argument 61 float a = coef * Q; in quant() 156 /** Return the minimum scalefactor where the quantized coef does not clip. */ 157 static inline uint8_t coef2minsf(float coef) in coef2minsf() argument 159 return av_clip_uint8(log2f(coef)*4 - 69 + SCALE_ONE_POS - SCALE_DIV_512); in coef2minsf() 162 /** Return the maximum scalefactor where the quantized coef is not zero. */ 163 static inline uint8_t coef2maxsf(float coef) in coef2maxsf() argument 165 return av_clip_uint8(log2f(coef)*4 + 6 + SCALE_ONE_POS - SCALE_DIV_512); in coef2maxsf()
|
H A D | ac3enc_float.c | 53 static void clip_coefficients(AudioDSPContext *adsp, float *coef, in clip_coefficients() argument 56 adsp->vector_clipf(coef, coef, len, COEF_MIN, COEF_MAX); in clip_coefficients()
|
H A D | ac3enc_fixed.c | 47 static void clip_coefficients(AudioDSPContext *adsp, int32_t *coef, in clip_coefficients() argument 50 adsp->vector_clip_int32(coef, coef, COEF_MIN, COEF_MAX, len); in clip_coefficients()
|
H A D | truespeech.c | 202 int coef; in truespeech_place_pulses() local 211 coef = dec->pulsepos[quart] >> 15; in truespeech_place_pulses() 216 if(coef >= t) in truespeech_place_pulses() 217 coef -= t; in truespeech_place_pulses() 224 coef = dec->pulsepos[quart] & 0x7FFF; in truespeech_place_pulses() 228 if(coef >= t) in truespeech_place_pulses() 229 coef -= t; in truespeech_place_pulses()
|
H A D | aac.h | 168 INTFLOAT coef; member 206 INTFLOAT coef[8][4][TNS_MAX_ORDER]; member 373 void (*apply_tns)(INTFLOAT coef[1024], TemporalNoiseShaping *tns,
|
/third_party/benchmark/src/ |
H A D | complexity.h | 34 // - coef : Estimated coefficient for the high-order term as 43 LeastSq() : coef(0.0), rms(0.0), complexity(oNone) {} in LeastSq() 45 double coef; member
|
H A D | complexity.cc | 102 result.coef = sigma_time_gn / sigma_gn_squared; 107 double fit = result.coef * fitting_curve(n[i]); 206 big_o.real_accumulated_time = result_real.coef; 207 big_o.cpu_accumulated_time = result_cpu.coef;
|
/third_party/ffmpeg/libavformat/ |
H A D | genh.c | 44 unsigned start_offset, header_size, codec, coef_type, coef[2]; in genh_read_header() local 121 coef[0] = avio_rl32(s->pb); in genh_read_header() 122 coef[1] = avio_rl32(s->pb); in genh_read_header() 140 avio_seek(s->pb, coef[ch], SEEK_SET); in genh_read_header()
|
/third_party/ffmpeg/libavcodec/x86/ |
H A D | ac3dsp_init.c | 33 void ff_ac3_extract_exponents_sse2 (uint8_t *exp, int32_t *coef, int nb_coefs); 34 void ff_ac3_extract_exponents_ssse3(uint8_t *exp, int32_t *coef, int nb_coefs);
|
/third_party/mesa3d/src/broadcom/simulator/ |
H A D | v3dx_simulator.c | 193 V3D_WRITE(V3D_TFU_COEF0, args->coef[0]); in simulator_submit_tfu_ioctl() 194 V3D_WRITE(V3D_TFU_COEF1, args->coef[1]); in simulator_submit_tfu_ioctl() 195 V3D_WRITE(V3D_TFU_COEF2, args->coef[2]); in simulator_submit_tfu_ioctl() 196 V3D_WRITE(V3D_TFU_COEF3, args->coef[3]); in simulator_submit_tfu_ioctl()
|
/third_party/pulseaudio/speex/libspeexdsp/ |
H A D | scal.c | 234 //float coef = .5*0.78130; in speex_decorrelate() 235 float coef = M_PI*0.075063 * 0.93763 * amount * .8 * 0.707; in speex_decorrelate() local 245 gain = coef*sqrt(.1+st->curve[i]); in speex_decorrelate() 249 frame[0] = coef*uni_rand(&st->seed)*sqrt(.1+st->curve[0]); in speex_decorrelate() 250 frame[2*st->frame_size-1] = coef*uni_rand(&st->seed)*sqrt(.1+st->curve[st->frame_size-1]); in speex_decorrelate()
|