/external/libopus/silk/fixed/ |
D | corrMatrix_FIX.c | 49 opus_int lag, i; in silk_corrVector_FIX() local 58 for( lag = 0; lag < order; lag++ ) { in silk_corrVector_FIX() 63 Xt[ lag ] = inner_prod; /* X[:,lag]'*t */ in silk_corrVector_FIX() 68 for( lag = 0; lag < order; lag++ ) { in silk_corrVector_FIX() 69 Xt[ lag ] = silk_inner_prod_aligned( ptr1, ptr2, L, arch ); /* X[:,lag]'*t */ in silk_corrVector_FIX() 86 opus_int i, j, lag, rshifts_local, head_room_rshifts; in silk_corrMatrix_FIX() local 123 for( lag = 1; lag < order; lag++ ) { in silk_corrMatrix_FIX() 130 matrix_ptr( XX, lag, 0, order ) = energy; in silk_corrMatrix_FIX() 131 matrix_ptr( XX, 0, lag, order ) = energy; in silk_corrMatrix_FIX() 132 for( j = 1; j < ( order - lag ); j++ ) { in silk_corrMatrix_FIX() [all …]
|
D | pitch_analysis_core_FIX.c | 109 opus_int CBimax, CBimax_new, CBimax_old, lag, start_lag, end_lag, lag_new; in silk_pitch_analysis_core() local 369 lag = -1; /* To check if lag with strong enough correlation has been found */ in silk_pitch_analysis_core() 445 lag = d; in silk_pitch_analysis_core() 450 if( lag == -1 ) { in silk_pitch_analysis_core() 487 silk_assert( lag == silk_SAT16( lag ) ); in silk_pitch_analysis_core() 489 lag = silk_RSHIFT( silk_SMULBB( lag, 3 ), 1 ); in silk_pitch_analysis_core() 491 lag = silk_LSHIFT( lag, 1 ); in silk_pitch_analysis_core() 493 lag = silk_SMULBB( lag, 3 ); in silk_pitch_analysis_core() 496 lag = silk_LIMIT_int( lag, min_lag, max_lag ); in silk_pitch_analysis_core() 497 start_lag = silk_max_int( lag - 2, min_lag ); in silk_pitch_analysis_core() [all …]
|
D | prefilter_FIX.c | 54 …opus_int lag, /* I Lag for harmonic shaping … 108 opus_int j, k, lag; in silk_prefilter_FIX() local 123 lag = P->lagPrev; in silk_prefilter_FIX() 129 lag = psEncCtrl->pitchL[ k ]; in silk_prefilter_FIX() 158 …silk_prefilt_FIX( P, x_filt_Q12, pxw_Q3, HarmShapeFIRPacked_Q12, Tilt_Q14, LF_shp_Q14, lag, psEnc-… in silk_prefilter_FIX() 177 …opus_int lag, /* I Lag for harmonic shaping … in silk_prefilt_FIX() argument 193 if( lag > 0 ) { in silk_prefilt_FIX() 196 idx = lag + LTP_shp_buf_idx; in silk_prefilt_FIX()
|
/external/libopus/silk/float/ |
D | corrMatrix_FLP.c | 47 opus_int lag; in silk_corrVector_FLP() local 51 for( lag = 0; lag < Order; lag++ ) { in silk_corrVector_FLP() 53 Xt[ lag ] = (silk_float)silk_inner_product_FLP( ptr1, t, L ); in silk_corrVector_FLP() 66 opus_int j, lag; in silk_corrMatrix_FLP() local 80 for( lag = 1; lag < Order; lag++ ) { in silk_corrMatrix_FLP() 83 matrix_ptr( XX, lag, 0, Order ) = ( silk_float )energy; in silk_corrMatrix_FLP() 84 matrix_ptr( XX, 0, lag, Order ) = ( silk_float )energy; in silk_corrMatrix_FLP() 86 for( j = 1; j < ( Order - lag ); j++ ) { in silk_corrMatrix_FLP() 88 matrix_ptr( XX, lag + j, j, Order ) = ( silk_float )energy; in silk_corrMatrix_FLP() 89 matrix_ptr( XX, j, lag + j, Order ) = ( silk_float )energy; in silk_corrMatrix_FLP()
|
D | pitch_analysis_core_FLP.c | 98 opus_int CBimax, CBimax_new, lag, start_lag, end_lag, lag_new; in silk_pitch_analysis_core_FLP() local 312 lag = -1; /* To check if lag with strong enough correlation has been found */ in silk_pitch_analysis_core_FLP() 376 lag = d; in silk_pitch_analysis_core_FLP() 381 if( lag == -1 ) { in silk_pitch_analysis_core_FLP() 398 silk_assert( lag == silk_SAT16( lag ) ); in silk_pitch_analysis_core_FLP() 400 lag = silk_RSHIFT_ROUND( silk_SMULBB( lag, 3 ), 1 ); in silk_pitch_analysis_core_FLP() 402 lag = silk_LSHIFT( lag, 1 ); in silk_pitch_analysis_core_FLP() 405 lag = silk_LIMIT_int( lag, min_lag, max_lag ); in silk_pitch_analysis_core_FLP() 406 start_lag = silk_max_int( lag - 2, min_lag ); in silk_pitch_analysis_core_FLP() 407 end_lag = silk_min_int( lag + 2, max_lag ); in silk_pitch_analysis_core_FLP() [all …]
|
D | prefilter_FLP.c | 46 opus_int lag, /* I */ 102 opus_int j, k, lag; in silk_prefilter_FLP() local 114 lag = P->lagPrev; in silk_prefilter_FLP() 118 lag = psEncCtrl->pitchL[ k ]; in silk_prefilter_FLP() 145 …silk_prefilt_FLP( P, pxw, pxw, HarmShapeFIR, Tilt, LF_MA_shp, LF_AR_shp, lag, psEnc->sCmn.subfr_le… in silk_prefilter_FLP() 164 opus_int lag, /* I */ in silk_prefilt_FLP() argument 181 if( lag > 0 ) { in silk_prefilt_FLP() 183 idx = lag + LTP_shp_buf_idx; in silk_prefilt_FLP()
|
/external/webrtc/webrtc/modules/audio_coding/codecs/ilbc/ |
D | enhancer_interface.c | 39 size_t lag=20, tlag=20; in WebRtcIlbcfix_EnhancerInterface() local 174 lag = lagmax[ind] + 10; in WebRtcIlbcfix_EnhancerInterface() 177 enh_period[ENH_NBLOCKS_TOT - new_blocks + iblock] = lag * 8; in WebRtcIlbcfix_EnhancerInterface() 182 tlag = lag * 2; in WebRtcIlbcfix_EnhancerInterface() 186 tlag = lag * 2; in WebRtcIlbcfix_EnhancerInterface() 190 lag *= 2; in WebRtcIlbcfix_EnhancerInterface() 215 lag=WebRtcSpl_MaxIndexW32(corr32, 3); in WebRtcIlbcfix_EnhancerInterface() 216 lag+=tlag-1; in WebRtcIlbcfix_EnhancerInterface() 221 if (lag>plc_blockl) { in WebRtcIlbcfix_EnhancerInterface() 222 WEBRTC_SPL_MEMCPY_W16(plc_pred, &in[lag-plc_blockl], plc_blockl); in WebRtcIlbcfix_EnhancerInterface() [all …]
|
D | decode.c | 191 size_t lag; in WebRtcIlbcfix_DecodeImpl() local 194 lag = 20; in WebRtcIlbcfix_DecodeImpl() 196 lag = WebRtcIlbcfix_XcorrCoef( in WebRtcIlbcfix_DecodeImpl() 198 &decresidual[iLBCdec_inst->blockl-60-lag], in WebRtcIlbcfix_DecodeImpl() 200 80, lag, -1); in WebRtcIlbcfix_DecodeImpl() 202 lag = WebRtcIlbcfix_XcorrCoef( in WebRtcIlbcfix_DecodeImpl() 204 &decresidual[iLBCdec_inst->blockl-ENH_BLOCKL-lag], in WebRtcIlbcfix_DecodeImpl() 206 100, lag, -1); in WebRtcIlbcfix_DecodeImpl() 210 (*iLBCdec_inst).last_lag = lag; in WebRtcIlbcfix_DecodeImpl()
|
D | get_cd_vec.c | 35 size_t lag; in WebRtcIlbcfix_GetCbVec() local 63 lag = k / 2; in WebRtcIlbcfix_GetCbVec() 65 WebRtcIlbcfix_CreateAugmentedVec(lag, mem+lMem, cbvec); in WebRtcIlbcfix_GetCbVec() 106 lag = (cbveclen<<1)-20+index-base_size-lMem-1; in WebRtcIlbcfix_GetCbVec() 108 WebRtcIlbcfix_CreateAugmentedVec(lag, tempbuff2+SUBL+5, cbvec); in WebRtcIlbcfix_GetCbVec()
|
D | do_plc.c | 44 size_t j, lag, randlag; in WebRtcIlbcfix_DoThePlc() local 87 lag = inlag - 3; in WebRtcIlbcfix_DoThePlc() 93 … iLBCdec_inst->prevResidual, lag, iLBCdec_inst->blockl, corrLen, scale3); in WebRtcIlbcfix_DoThePlc() 132 lag = j; in WebRtcIlbcfix_DoThePlc() 181 lag = iLBCdec_inst->prevLag; in WebRtcIlbcfix_DoThePlc() 226 use_lag = lag; in WebRtcIlbcfix_DoThePlc() 227 if (lag<80) { in WebRtcIlbcfix_DoThePlc() 228 use_lag = 2*lag; in WebRtcIlbcfix_DoThePlc() 287 iLBCdec_inst->prevLag = lag; in WebRtcIlbcfix_DoThePlc()
|
D | comp_corr.c | 30 size_t lag, /* (i) pitch lag */ in WebRtcIlbcfix_CompCorr() argument 37 w16ptr=&buffer[bLen-sRange-lag]; in WebRtcIlbcfix_CompCorr()
|
/external/flac/libFLAC/include/private/ |
D | lpc.h | 71 void FLAC__lpc_compute_autocorrelation(const FLAC__real data[], unsigned data_len, unsigned lag, FL… 75 …ocorrelation_asm_ia32(const FLAC__real data[], unsigned data_len, unsigned lag, FLAC__real autoc[]… 76 …sm_ia32_sse_lag_4_old(const FLAC__real data[], unsigned data_len, unsigned lag, FLAC__real autoc[]… 77 …sm_ia32_sse_lag_8_old(const FLAC__real data[], unsigned data_len, unsigned lag, FLAC__real autoc[]… 78 …m_ia32_sse_lag_12_old(const FLAC__real data[], unsigned data_len, unsigned lag, FLAC__real autoc[]… 79 …m_ia32_sse_lag_16_old(const FLAC__real data[], unsigned data_len, unsigned lag, FLAC__real autoc[]… 84 …_intrin_sse_lag_4_old(const FLAC__real data[], unsigned data_len, unsigned lag, FLAC__real autoc[]… 85 …_intrin_sse_lag_8_old(const FLAC__real data[], unsigned data_len, unsigned lag, FLAC__real autoc[]… 86 …intrin_sse_lag_12_old(const FLAC__real data[], unsigned data_len, unsigned lag, FLAC__real autoc[]… 87 …intrin_sse_lag_16_old(const FLAC__real data[], unsigned data_len, unsigned lag, FLAC__real autoc[]… [all …]
|
/external/speex/libspeex/ |
D | lpc.c | 131 int lag, in _spx_autocorr() argument 157 for (i=0;i<lag;i++) in _spx_autocorr() 184 int lag, in _spx_autocorr() argument 190 while (lag--) in _spx_autocorr() 192 for (i = lag, d = 0; i < n; i++) in _spx_autocorr() 193 d += x[i] * x[i-lag]; in _spx_autocorr() 194 ac[lag] = d; in _spx_autocorr()
|
D | lpc_bfin.h | 40 int lag, in _spx_autocorr() argument 50 ac32top = ac32+lag-1; in _spx_autocorr() 53 lag_1 = lag-1; in _spx_autocorr() 71 xs = x+lag-1; in _spx_autocorr() 119 for (i=0;i<lag;i++) in _spx_autocorr()
|
/external/libopus/silk/ |
D | NSQ.c | 62 opus_int lag, /* I Pitch lag */ 95 opus_int k, lag, start_idx, LSF_interpolation_flag; in silk_NSQ_c() local 108 lag = NSQ->lagPrev; in silk_NSQ_c() 141 lag = pitchL[ k ]; in silk_NSQ_c() 146 start_idx = psEncC->ltp_mem_length - lag - psEncC->predictLPCOrder - LTP_ORDER / 2; in silk_NSQ_c() 160 …AR_shp_Q13, lag, HarmShapeFIRPacked_Q14, Tilt_Q14[ k ], LF_shp_Q14[ k ], Gains_Q16[ k ], Lambda_Q1… in silk_NSQ_c() 195 opus_int lag, /* I Pitch lag */ in silk_noise_shape_quantizer() argument 218 shp_lag_ptr = &NSQ->sLTP_shp_Q14[ NSQ->sLTP_shp_buf_idx - lag + HARM_SHAPE_FIR_TAPS / 2 ]; in silk_noise_shape_quantizer() 219 pred_lag_ptr = &sLTP_Q15[ NSQ->sLTP_buf_idx - lag + LTP_ORDER / 2 ]; in silk_noise_shape_quantizer() 260 silk_assert( lag > 0 || signalType != TYPE_VOICED ); in silk_noise_shape_quantizer() [all …]
|
D | decode_pitch.c | 46 opus_int lag, k, min_lag, max_lag, cbk_size; in silk_decode_pitch() local 71 lag = min_lag + lagIndex; in silk_decode_pitch() 74 pitch_lags[ k ] = lag + matrix_ptr( Lag_CB_ptr, k, contourIndex, cbk_size ); in silk_decode_pitch()
|
D | NSQ_del_dec.c | 97 opus_int lag, /* I Pitch lag */ 133 opus_int i, k, lag, start_idx, LSF_interpolation_flag, Winner_ind, subfr; in silk_NSQ_del_dec_c() local 149 lag = NSQ->lagPrev; in silk_NSQ_del_dec_c() 178 if( lag > 0 ) { in silk_NSQ_del_dec_c() 179 decisionDelay = silk_min_int( decisionDelay, lag - LTP_ORDER / 2 - 1 ); in silk_NSQ_del_dec_c() 212 lag = pitchL[ k ]; in silk_NSQ_del_dec_c() 249 start_idx = psEncC->ltp_mem_length - lag - psEncC->predictLPCOrder - LTP_ORDER / 2; in silk_NSQ_del_dec_c() 264 …delayedGain_Q10, A_Q12, B_Q14, AR_shp_Q13, lag, HarmShapeFIRPacked_Q14, Tilt_Q14[ k ], LF_shp_Q14[… in silk_NSQ_del_dec_c() 325 opus_int lag, /* I Pitch lag */ in silk_noise_shape_quantizer_del_dec() argument 362 shp_lag_ptr = &NSQ->sLTP_shp_Q14[ NSQ->sLTP_shp_buf_idx - lag + HARM_SHAPE_FIR_TAPS / 2 ]; in silk_noise_shape_quantizer_del_dec() [all …]
|
D | decode_core.c | 46 opus_int i, k, lag = 0, start_idx, sLTP_buf_idx, NLSF_interpolation_flag, signalType; in silk_decode_core() local 138 lag = psDecCtrl->pitchL[ k ]; in silk_decode_core() 143 start_idx = psDec->ltp_mem_length - lag - psDec->LPC_order - LTP_ORDER / 2; in silk_decode_core() 158 for( i = 0; i < lag + LTP_ORDER/2; i++ ) { in silk_decode_core() 164 for( i = 0; i < lag + LTP_ORDER/2; i++ ) { in silk_decode_core() 174 pred_lag_ptr = &sLTP_Q15[ sLTP_buf_idx - lag + LTP_ORDER / 2 ]; in silk_decode_core()
|
/external/aac/libAACenc/src/ |
D | aacenc_tns.cpp | 516 const INT lag, in FDKaacEnc_CalcAutoCorrValue() argument 523 if (lag==0) { in FDKaacEnc_CalcAutoCorrValue() 529 for (i=startLine; i<(stopLine-lag); i++) { in FDKaacEnc_CalcAutoCorrValue() 530 result += (fMult(spectrum[i], spectrum[i+lag])>>scale); in FDKaacEnc_CalcAutoCorrValue() 597 int i, idx0, idx1, idx2, idx3, idx4, lag; in FDKaacEnc_MergedAutoCorrelation() local 658 for (lag = 1; lag <= maxOrder; lag++) { in FDKaacEnc_MergedAutoCorrelation() 660 FIXP_DBL x1 = FDKaacEnc_CalcAutoCorrValue(pSpectrum, idx0, idx1, lag, nsc1); in FDKaacEnc_MergedAutoCorrelation() 661 _rxx1[lag] = fMult(scaleValue(fMult(x1,fac1),sc_fac1), acfWindow[LOFILT][lag]); in FDKaacEnc_MergedAutoCorrelation() 666 for (lag = 1; lag <= maxOrder; lag++) { in FDKaacEnc_MergedAutoCorrelation() 667 if ((3 * lag) <= maxOrder + 3) { in FDKaacEnc_MergedAutoCorrelation() [all …]
|
/external/webrtc/webrtc/modules/audio_coding/codecs/isac/main/source/ |
D | filter_functions.c | 99 size_t lag, n; in WebRtcIsac_AutoCorr() local 103 for (lag = 0; lag <= order; lag++) in WebRtcIsac_AutoCorr() 106 x_lag = &x[lag]; in WebRtcIsac_AutoCorr() 108 for (n = 1; n < N - lag; n++) { in WebRtcIsac_AutoCorr() 113 r[lag] = sum; in WebRtcIsac_AutoCorr()
|
/external/libopus/silk/x86/ |
D | NSQ_sse.c | 63 opus_int lag, /* I Pitch lag */ 91 opus_int k, lag, start_idx, LSF_interpolation_flag; in silk_NSQ_sse4_1() local 109 lag = NSQ->lagPrev; in silk_NSQ_sse4_1() 196 lag = pitchL[ k ]; in silk_NSQ_sse4_1() 201 start_idx = psEncC->ltp_mem_length - lag - psEncC->predictLPCOrder - LTP_ORDER / 2; in silk_NSQ_sse4_1() 217 … AR_shp_Q13, lag, HarmShapeFIRPacked_Q14, Tilt_Q14[ k ], LF_shp_Q14[ k ], Gains_Q16[ k ], in silk_NSQ_sse4_1() 223 …AR_shp_Q13, lag, HarmShapeFIRPacked_Q14, Tilt_Q14[ k ], LF_shp_Q14[ k ], Gains_Q16[ k ], Lambda_Q1… in silk_NSQ_sse4_1() 255 opus_int lag, /* I Pitch lag */ in silk_noise_shape_quantizer_10_16_sse4_1() argument 283 shp_lag_ptr = &NSQ->sLTP_shp_Q14[ NSQ->sLTP_shp_buf_idx - lag + HARM_SHAPE_FIR_TAPS / 2 ]; in silk_noise_shape_quantizer_10_16_sse4_1() 284 pred_lag_ptr = &sLTP_Q15[ NSQ->sLTP_buf_idx - lag + LTP_ORDER / 2 ]; in silk_noise_shape_quantizer_10_16_sse4_1() [all …]
|
D | NSQ_del_dec_sse.c | 97 opus_int lag, /* I Pitch lag */ 132 opus_int i, k, lag, start_idx, LSF_interpolation_flag, Winner_ind, subfr; in silk_NSQ_del_dec_sse4_1() local 148 lag = NSQ->lagPrev; in silk_NSQ_del_dec_sse4_1() 177 if( lag > 0 ) { in silk_NSQ_del_dec_sse4_1() 178 decisionDelay = silk_min_int( decisionDelay, lag - LTP_ORDER / 2 - 1 ); in silk_NSQ_del_dec_sse4_1() 211 lag = pitchL[ k ]; in silk_NSQ_del_dec_sse4_1() 248 start_idx = psEncC->ltp_mem_length - lag - psEncC->predictLPCOrder - LTP_ORDER / 2; in silk_NSQ_del_dec_sse4_1() 263 …delayedGain_Q10, A_Q12, B_Q14, AR_shp_Q13, lag, HarmShapeFIRPacked_Q14, Tilt_Q14[ k ], LF_shp_Q14[… in silk_NSQ_del_dec_sse4_1() 323 opus_int lag, /* I Pitch lag */ in silk_noise_shape_quantizer_del_dec_sse4_1() argument 358 shp_lag_ptr = &NSQ->sLTP_shp_Q14[ NSQ->sLTP_shp_buf_idx - lag + HARM_SHAPE_FIR_TAPS / 2 ]; in silk_noise_shape_quantizer_del_dec_sse4_1() [all …]
|
/external/swiftshader/third_party/LLVM/test/CodeGen/X86/ |
D | pr3154.ll | 5 define void @ff_flac_compute_autocorr_sse2(i32* %data, i32 %len, i32 %lag, double* %autoc) nounwind… 9 %1 = add i32 %0, %lag ; <i32> [#uses=1] 11 %3 = getelementptr double* %2, i32 %lag ; <double*> [#uses=2] 18 %.sum = add i32 %lag, 1 ; <i32> [#uses=1] 48 %18 = icmp sgt i32 %lag, 0 ; <i1> [#uses=2] 53 %19 = sub i32 %j4.042, %lag ; <i32> [#uses=1] 57 %exitcond = icmp eq i32 %indvar.next45, %lag ; <i1> [#uses=1] 67 %23 = add i32 %lag, -2 ; <i32> [#uses=1] 98 %34 = icmp slt i32 %.pre-phi, %lag ; <i1> [#uses=1]
|
/external/llvm/test/CodeGen/X86/ |
D | pr3154.ll | 5 define void @ff_flac_compute_autocorr_sse2(i32* %data, i32 %len, i32 %lag, double* %autoc) nounwind… 9 %1 = add i32 %0, %lag ; <i32> [#uses=1] 11 %3 = getelementptr double, double* %2, i32 %lag ; <double*> [#uses=2] 18 %.sum = add i32 %lag, 1 ; <i32> [#uses=1] 48 %18 = icmp sgt i32 %lag, 0 ; <i1> [#uses=2] 53 %19 = sub i32 %j4.042, %lag ; <i32> [#uses=1] 57 %exitcond = icmp eq i32 %indvar.next45, %lag ; <i1> [#uses=1] 67 %23 = add i32 %lag, -2 ; <i32> [#uses=1] 98 %34 = icmp slt i32 %.pre-phi, %lag ; <i1> [#uses=1]
|
/external/jemalloc/test/src/ |
D | SFMT.c | 643 int lag; in init_by_array() local 655 lag = 11; in init_by_array() 657 lag = 7; in init_by_array() 659 lag = 5; in init_by_array() 661 lag = 3; in init_by_array() 663 mid = (size - lag) / 2; in init_by_array() 675 psfmt32[idxof(mid + lag)] += r; in init_by_array() 684 psfmt32[idxof((i + mid + lag) % N32)] += r; in init_by_array() 693 psfmt32[idxof((i + mid + lag) % N32)] += r; in init_by_array() 702 psfmt32[idxof((i + mid + lag) % N32)] ^= r; in init_by_array()
|