/frameworks/av/media/libstagefright/codecs/amrwbenc/src/ |
D | levinson.c | 121 Word32 t0, t1, t2; /* temporary variable */ in Levinson() local 132 t0 = Div_32(t2, Rh[0], Rl[0]); /* R[1]/R[0] in Q31 */ in Levinson() 134 t0 = -t0; /* -R[1]/R[0] */ in Levinson() 136 Kh = t0 >> 16; in Levinson() 137 Kl = (t0 & 0xffff)>>1; in Levinson() 139 t0 = (t0 >> 4); /* A[1] in Q27 */ in Levinson() 141 Ah[1] = t0 >> 16; in Levinson() 142 Al[1] = (t0 & 0xffff)>>1; in Levinson() 145 t0 = Mpy_32(Kh, Kl, Kh, Kl); /* K*K in Q31 */ in Levinson() 146 t0 = L_abs(t0); /* Some case <0 !! */ in Levinson() [all …]
|
D | az_isp.c | 71 Word32 t0; in Az_isp() local 89 t0 = a[i] << 15; in Az_isp() 90 f1[i] = vo_round(t0 + (a[M - i] << 15)); /* =(a[i]+a[M-i])/2 */ in Az_isp() 91 f2[i] = vo_round(t0 - (a[M - i] << 15)); /* =(a[i]-a[M-i])/2 */ in Az_isp() 155 t0 = x * y; in Az_isp() 156 t0 = (t0 >> (19 - exp)); in Az_isp() 157 y = vo_extract_l(t0); /* y= (xhigh-xlow)/(yhigh-ylow) in Q11 */ in Az_isp() 160 t0 = ylow * y; /* result in Q26 */ in Az_isp() 161 t0 = (t0 >> 10); /* result in Q15 */ in Az_isp() 162 xint = vo_sub(xlow, vo_extract_l(t0)); /* xint = xlow - ylow*y */ in Az_isp() [all …]
|
D | isp_az.c | 49 Word32 t0; in Isp_Az() local 94 t0 = Mpy_32_16(hi, lo, isp[m - 1]); in Isp_Az() 95 f1[i] = vo_L_add(f1[i], t0); in Isp_Az() 101 t0 = Mpy_32_16(hi, lo, isp[m - 1]); in Isp_Az() 102 f2[i] = vo_L_sub(f2[i], t0); in Isp_Az() 117 t0 = vo_L_add(f1[i], f2[i]); /* f1[i] + f2[i] */ in Isp_Az() 118 tmax |= L_abs(t0); in Isp_Az() 119 a[i] = (Word16)(vo_L_shr_r(t0, 12)); /* from Q23 to Q12 and * 0.5 */ in Isp_Az() 123 t0 = vo_L_sub(f1[i], f2[i]); /* f1[i] - f2[i] */ in Isp_Az() 124 tmax |= L_abs(t0); in Isp_Az() [all …]
|
D | pitch_f4.c | 81 Word16 max, t0, step, temp; in Pitch_fr4() local 100 t0 = t0_min; in Pitch_fr4() 106 t0 = i; in Pitch_fr4() 110 if ((i_subfr == 0) && (t0 >= t0_fr1)) in Pitch_fr4() 113 return (t0); in Pitch_fr4() 123 if ((t0_fr2 == PIT_MIN)||((i_subfr == 0) && (t0 >= t0_fr2))) in Pitch_fr4() 128 if(t0 == t0_min) in Pitch_fr4() 132 max = Interpol_4(&corr[t0], fraction); in Pitch_fr4() 136 temp = Interpol_4(&corr[t0], i); in Pitch_fr4() 147 t0 -= 1; in Pitch_fr4() [all …]
|
/frameworks/av/media/libstagefright/codecs/amrnb/enc/src/ |
D | levinson.cpp | 654 Word32 t0; /* temporary variable */ in Levinson() local 671 t0 = Div_32(t2, *Rh, *Rl, pOverflow); /* R[1]/R[0] */ in Levinson() 675 t0 = L_negate(t0); /* -R[1]/R[0] */ in Levinson() 679 Kh = (Word16)(t0 >> 16); in Levinson() 680 Kl = (Word16)((t0 >> 1) - ((Word32)(Kh) << 15)); in Levinson() 682 *rc = pv_round(t0, pOverflow); in Levinson() 684 t0 = t0 >> 4; in Levinson() 687 *(Ah + 1) = (Word16)(t0 >> 16); in Levinson() 689 *(Al + 1) = (Word16)((t0 >> 1) - ((Word32)(*(Ah + 1)) << 15)); in Levinson() 692 t0 = Mpy_32(Kh, Kl, Kh, Kl, pOverflow); /* K*K */ in Levinson() [all …]
|
D | hp_max.cpp | 249 Word32 max, t0, t1; in hp_max() local 255 t0 = 0L; in hp_max() 260 t0 = L_shl(corr[-i], 1, pOverflow); in hp_max() 261 L_temp = L_sub(t0, corr[-i-1], pOverflow); in hp_max() 262 t0 = L_sub(L_temp, corr[-i+1], pOverflow); in hp_max() 263 t0 = L_abs(t0); in hp_max() 265 if (t0 >= max) in hp_max() 267 max = t0; in hp_max() 274 t0 = 0L; in hp_max() 277 t0 = L_mac(t0, *p, *p1, pOverflow); in hp_max() [all …]
|
D | pitch_ol.cpp | 326 Word32 t0; in Lag_max() local 354 t0 = 0; in Lag_max() 361 t0 = amrnb_fxp_mac_16_by_16bb((Word32) * (p), (Word32) * (p), t0); in Lag_max() 363 t0 = amrnb_fxp_mac_16_by_16bb((Word32) * (p), (Word32) * (p), t0); in Lag_max() 365 t0 = amrnb_fxp_mac_16_by_16bb((Word32) * (p), (Word32) * (p), t0); in Lag_max() 367 t0 = amrnb_fxp_mac_16_by_16bb((Word32) * (p), (Word32) * (p), t0); in Lag_max() 371 t0 <<= 1; in Lag_max() 379 *r0 = t0; in Lag_max() 382 vad_tone_detection(vadSt, max, t0, pOverflow); in Lag_max() 386 t0 = Inv_sqrt(t0, pOverflow); in Lag_max() [all …]
|
D | p_ol_wgh.cpp | 591 Word32 t0; in Lag_max() local 608 t0 = corr[-i]; in Lag_max() 612 t0 = Mpy_32_16(t0_h, t0_l, *ww, pOverflow); in Lag_max() 617 L_Extract(t0, &t0_h, &t0_l, pOverflow); in Lag_max() 618 t0 = Mpy_32_16(t0_h, t0_l, *we, pOverflow); in Lag_max() 623 if (t0 >= max) in Lag_max() 625 max = t0; in Lag_max() 631 t0 = 0; in Lag_max() 636 t0 = L_mac(t0, *p, *p1, pOverflow); in Lag_max() 644 vadSt->L_Rmax = L_add(vadSt->L_Rmax, t0, pOverflow); in Lag_max() [all …]
|
/frameworks/av/media/libstagefright/codecs/aacenc/src/ |
D | bit_cnt.c | 46 Word32 t0,t1,t2,t3,i; in count1_2_3_4_5_6_7_8_9_10_11() local 60 t0= values[i+0]; in count1_2_3_4_5_6_7_8_9_10_11() 67 bc1_2 = bc1_2 + EXPAND(huff_ltab1_2[t0+1][t1+1][t2+1][t3+1]); in count1_2_3_4_5_6_7_8_9_10_11() 70 bc5_6 = bc5_6 + EXPAND(huff_ltab5_6[t0+4][t1+4]); in count1_2_3_4_5_6_7_8_9_10_11() 73 t0=ABS(t0); in count1_2_3_4_5_6_7_8_9_10_11() 79 bc3_4 = bc3_4 + EXPAND(huff_ltab3_4[t0][t1][t2][t3]); in count1_2_3_4_5_6_7_8_9_10_11() 81 bc7_8 = bc7_8 + EXPAND(huff_ltab7_8[t0][t1]); in count1_2_3_4_5_6_7_8_9_10_11() 84 bc9_10 = bc9_10 + EXPAND(huff_ltab9_10[t0][t1]); in count1_2_3_4_5_6_7_8_9_10_11() 87 bc11 = bc11 + huff_ltab11[t0][t1]; in count1_2_3_4_5_6_7_8_9_10_11() 91 sc = sc + (t0>0) + (t1>0) + (t2>0) + (t3>0); in count1_2_3_4_5_6_7_8_9_10_11() [all …]
|
D | transform.c | 114 int t0, t1, t2, t3; in Radix8First() local 145 t0 = (r0 + r2) >> 1; in Radix8First() 150 buf[ 0] = r4 + t0; in Radix8First() 152 buf[ 8] = r4 - t0; in Radix8First() 164 t0 = MULHIGH(SQRT1_2, r0 - i0); in Radix8First() 169 buf[ 6] = r6 - t0; in Radix8First() 171 buf[14] = r6 + t0; in Radix8First() 192 int t0, t1; in Radix4FFT() local 212 t0 = xptr[0]; in Radix4FFT() 216 r2 = MULHIGH(cosx, t0) + MULHIGH(sinx, t1); /* cos*br + sin*bi */ in Radix4FFT() [all …]
|
/frameworks/av/media/libstagefright/codecs/amrwb/src/ |
D | isp_az.cpp | 144 int32 t0; in Isp_Az() local 189 t0 = f1[i]; in Isp_Az() 191 t0 = fxp_mul32_by_16b(t0, isp[m - 1]) << 1; in Isp_Az() 193 f1[i] += t0; in Isp_Az() 211 t0 = add_int32(f1[i], f2[i]); /* f1[i] + f2[i] */ in Isp_Az() 213 t1 = t0 - (t0 < 0); in Isp_Az() 218 a[i] = (int16)((t0 >> 12) + ((t0 >> 11) & 1)); in Isp_Az() 223 t0 = sub_int32(f1[i], f2[i]); /* f1[i] - f2[i] */ in Isp_Az() 225 t1 = t0 - (t0 < 0); in Isp_Az() 231 a[j--] = (int16)((t0 >> 12) + ((t0 >> 11) & 1)); in Isp_Az() [all …]
|
/frameworks/av/media/libstagefright/codecs/amrnb/common/src/ |
D | az_lsp.cpp | 252 Word32 t0; in Chebps() local 262 t0 = ((Word32) x << 10) + ((Word32) * (p_f++) << 14); in Chebps() 266 b1_h = (Word16)(t0 >> 16); in Chebps() 267 b1_l = (Word16)((t0 >> 1) - (b1_h << 15)); in Chebps() 273 t0 = ((Word32) b1_h * x); in Chebps() 274 t0 += ((Word32) b1_l * x) >> 15; in Chebps() 275 t0 <<= 2; in Chebps() 278 t0 -= L_temp; in Chebps() 281 t0 += (Word32) * (p_f++) << 14; in Chebps() 286 b1_h = (Word16)(t0 >> 16); in Chebps() [all …]
|
D | lsp_az.cpp | 262 Word32 t0; in Get_lsp_pol() local 280 t0 = ((Word32)hi * *lsp); in Get_lsp_pol() 281 t0 += ((Word32)lo * *lsp) >> 15; in Get_lsp_pol() 284 *(f--) -= t0 << 2; /* *f -= t0 */ in Get_lsp_pol() 519 Word32 t0; in Lsp_Az() local 544 t0 = *(p_f1) + *(p_f2); /* f1[i] + f2[i] */ in Lsp_Az() 547 t0 = t0 + ((Word32) 1 << 12); in Lsp_Az() 550 *(p_a++) = (Word16)(t0 >> 13); in Lsp_Az()
|
/frameworks/av/media/libstagefright/codecs/amrnb/dec/src/ |
D | ex_ctrl.cpp | 162 Word32 t0; in Ex_ctrl() local 194 t0 = L_mult(avgEnergy, excEnergy, pOverflow); in Ex_ctrl() 195 t0 = L_shr(t0, sub(20, exp, pOverflow), pOverflow); in Ex_ctrl() 197 if (t0 > 32767) in Ex_ctrl() 199 t0 = 32767; /* saturate */ in Ex_ctrl() 201 scaleFactor = extract_l(t0); in Ex_ctrl() 212 t0 = L_mult(scaleFactor, excitation[i], pOverflow); in Ex_ctrl() 213 t0 = L_shr(t0, 11, pOverflow); in Ex_ctrl() 214 excitation[i] = extract_l(t0); in Ex_ctrl()
|
/frameworks/base/tools/layoutlib/bridge/src/com/android/layoutlib/bridge/util/ |
D | CachedPathIteratorFactory.java | 128 private static void quadCurveSegment(float[] coords, float t0, float t1) { in quadCurveSegment() argument 130 float mt = t0 + (t1 - t0) / 2; in quadCurveSegment() 135 float u0 = 1 - t0; in quadCurveSegment() 139 coords[0] = coords[0] * u0 * u0 + coords[2] * 2 * t0 * u0 + coords[4] * t0 * t0; in quadCurveSegment() 140 coords[1] = coords[1] * u0 * u0 + coords[3] * 2 * t0 * u0 + coords[5] * t0 * t0; in quadCurveSegment() 151 private static void cubicCurveSegment(float[] coords, float t0, float t1) { in cubicCurveSegment() argument 153 float u0 = 1 - t0; in cubicCurveSegment() 158 float qxa = coords[0] * u0 * u0 + coords[2] * 2 * t0 * u0 + coords[4] * t0 * t0; in cubicCurveSegment() 160 float qxc = coords[2] * u0 * u0 + coords[4] * 2 * t0 * u0 + coords[6] * t0 * t0; in cubicCurveSegment() 163 float qya = coords[1] * u0 * u0 + coords[3] * 2 * t0 * u0 + coords[5] * t0 * t0; in cubicCurveSegment() [all …]
|
/frameworks/compile/slang/tests/P_reduce_general_inputs/ |
D | ScriptC_reduce_general_inputs.java.expect | 157 Type t0, t1; 167 t0 = ain1.getType(); 169 if ((t0.getCount() != t1.getCount()) || 170 (t0.getX() != t1.getX()) || 171 (t0.getY() != t1.getY()) || 172 (t0.getZ() != t1.getZ()) || 173 (t0.hasFaces() != t1.hasFaces()) || 174 (t0.hasMipmaps() != t1.hasMipmaps())) { 221 Type t0, t1; 231 t0 = ain1.getType(); [all …]
|
/frameworks/av/media/libstagefright/codecs/aacenc/src/asm/ARMV5E/ |
D | Radix4FFT_v5.s | 61 smulwt r4, r10, r8 @ L_mpy_wx(cosx, t0) 64 smlawb r2, r11, r8, r4 @ r2 = L_mpy_wx(cosx, t0) + L_mpy_wx(sinx, t1)@ 65 smulwb r5, r10, r8 @ L_mpy_wx(sinx, t0) 67 mov r10, r0, asr #2 @ t0 = r0 >> 2@ 70 sub r3, r3, r5 @ r3 = L_mpy_wx(cosx, t1) - L_mpy_wx(sinx, t0)@ 73 sub r0, r10, r2 @ r0 = t0 - r2@ 76 add r2, r10, r2 @ r2 = t0 + r2@ 85 smulwt r6, r10, r8 @ L_mpy_wx(cosx, t0) 88 smlawb r4, r11, r8, r6 @ r4 = L_mpy_wx(cosx, t0) + L_mpy_wx(sinx, t1)@ 89 smulwb r7, r10, r8 @ L_mpy_wx(sinx, t0) [all …]
|
/frameworks/av/media/libstagefright/codecs/aacenc/src/asm/ARMV7/ |
D | Radix4FFT_v7.s | 64 VQDMULH.S32 Q10, Q2, Q14 @ MULHIGH(cosx, t0) 67 VQDMULH.S32 Q13, Q2, Q15 @ MULHIGH(sinx, t0) 69 VADD.S32 Q2, Q10, Q11 @ MULHIGH(cosx, t0) + MULHIGH(sinx, t1) 70 VSUB.S32 Q3, Q12, Q13 @ MULHIGH(cosx, t1) - MULHIGH(sinx, t0) 73 VSHR.S32 Q10, Q0, #2 @ t0 = r0 >> 2@ 76 VSUB.S32 Q0, Q10, Q2 @ r0 = t0 - r2@ 78 VADD.S32 Q2, Q10, Q2 @ r2 = t0 + r2@ 85 VQDMULH.S32 Q10, Q4, Q14 @ MULHIGH(cosx, t0) 88 VQDMULH.S32 Q13, Q4, Q15 @ MULHIGH(sinx, t0) 90 VADD.S32 Q8, Q10, Q11 @ MULHIGH(cosx, t0) + MULHIGH(sinx, t1) [all …]
|
/frameworks/rs/cpu_ref/ |
D | rsCpuIntrinsics_x86.cpp | 763 __m128i t0, t1, t2, t3; in rsdIntrinsicBlendSrcOver_K() local 777 t0 = _mm_unpacklo_epi8(out0, _mm_setzero_si128()); in rsdIntrinsicBlendSrcOver_K() 778 t0 = _mm_mullo_epi16(t0, _mm_sub_epi16(all1s, ina)); in rsdIntrinsicBlendSrcOver_K() 779 t0 = _mm_srli_epi16(t0, 8); in rsdIntrinsicBlendSrcOver_K() 780 t0 = _mm_add_epi16(t0, ins); in rsdIntrinsicBlendSrcOver_K() 806 t0 = _mm_packus_epi16(t0, t1); in rsdIntrinsicBlendSrcOver_K() 808 _mm_storeu_si128((__m128i *)dst, t0); in rsdIntrinsicBlendSrcOver_K() 819 __m128i t0, t1, t2, t3; in rsdIntrinsicBlendDstOver_K() local 834 t0 = _mm_unpacklo_epi8(in0, _mm_setzero_si128()); in rsdIntrinsicBlendDstOver_K() 835 t0 = _mm_mullo_epi16(t0, _mm_sub_epi16(all1s, outa)); in rsdIntrinsicBlendDstOver_K() [all …]
|
/frameworks/av/media/libstagefright/codecs/on2/h264dec/omxdl/arm11/vc/m4p10/src/ |
D | armVCM4P10_DeblockingLuma_unsafe_s.s | 110 t0 RN 3 label 215 USUB8 t0, Q1a, max 217 USUB8 t0, Q1a, min 222 USUB8 t0, apflg, m01 224 USUB8 t0, aqflg, m01 331 SADD8 t0, t4, a 332 SHADD8 t9, t0, t9 337 SHADD8 t0, t0, a 339 SHADD8 a, t0, m01 359 SADD8 t4, t0, t4 [all …]
|
/frameworks/compile/mclinker/include/mcld/Support/ |
D | CXADemangle.tcc | 809 const char* t0 = parse_number(first+2, last); in parse_function_param() local 810 if (t0 != last && *t0 == 'p') in parse_function_param() 812 ++t0; in parse_function_param() 813 const char* t = parse_cv_qualifiers(t0, last, cv); in parse_function_param() 2967 const char* t0 = first+2; in parse_unnamed_type_name() local 2968 if (t0 == last) in parse_unnamed_type_name() 2973 if (std::isdigit(*t0)) in parse_unnamed_type_name() 2975 const char* t1 = t0 + 1; in parse_unnamed_type_name() 2978 db.names.back().first.append(t0, t1); in parse_unnamed_type_name() 2979 t0 = t1; in parse_unnamed_type_name() [all …]
|
/frameworks/av/media/libeffects/lvm/lib/Eq/src/ |
D | LVEQNB_CalcCoef.c | 111 LVM_INT16 t0; in LVEQNB_DoublePrecCoefs() local 141 t0 = (LVM_INT16)(T0 >> 16); in LVEQNB_DoublePrecCoefs() 148 factor = (factor * t0) >> 15; /* Calculate t0^n */ in LVEQNB_DoublePrecCoefs() 242 LVM_INT16 t0; in LVEQNB_SinglePrecCoefs() local 272 t0 = (LVM_INT16)(T0 >> 16); in LVEQNB_SinglePrecCoefs() 279 factor = (factor * t0) >> 15; /* Calculate t0^n */ in LVEQNB_SinglePrecCoefs()
|
/frameworks/support/samples/Support7Demos/src/com/example/android/supportv7/util/ |
D | SortedListActivity.java | 80 public int compare(Item t0, Item t1) { in SortedListAdapter() 81 if (t0.mIsDone != t1.mIsDone) { in SortedListAdapter() 82 return t0.mIsDone ? 1 : -1; in SortedListAdapter() 84 int txtComp = t0.mText.compareTo(t1.mText); in SortedListAdapter() 88 if (t0.id < t1.id) { in SortedListAdapter() 90 } else if (t0.id > t1.id) { in SortedListAdapter()
|
/frameworks/native/opengl/libagl/arch-mips/ |
D | fixed_asm.S | 34 srl $t0,$a0,31 /* t0 <- sign bit */ 50 movn $v0,$t2,$t0 /* if negative? */ 59 movz $v0,$t1,$t0 /* positive, maximum value */
|
/frameworks/av/media/libeffects/lvm/lib/SpectrumAnalyzer/src/ |
D | LVPSA_Control.c | 486 LVM_INT16 t0; in LVPSA_BPSinglePrecCoefs() local 519 t0 = (LVM_INT16)(T0 >> 16); in LVPSA_BPSinglePrecCoefs() 526 factor = (factor * t0) >> 15; /* Calculate t0^n */ in LVPSA_BPSinglePrecCoefs() 609 LVM_INT16 t0; in LVPSA_BPDoublePrecCoefs() local 641 t0 = (LVM_INT16)(T0 >> 16); in LVPSA_BPDoublePrecCoefs() 648 factor = (factor * t0) >> 15; /* Calculate t0^n */ in LVPSA_BPDoublePrecCoefs()
|