M_PI 193 doc/examples/decoding_encoding.c tincr = 2 * M_PI * 440.0 / c->sample_rate; M_PI 264 doc/examples/filter_audio.c data[j] = sin(2 * M_PI * (frame_num + j) * (i + 1) / FRAME_SIZE); M_PI 229 doc/examples/muxing.c ost->tincr = 2 * M_PI * 110.0 / c->sample_rate; M_PI 231 doc/examples/muxing.c ost->tincr2 = 2 * M_PI * 110.0 / c->sample_rate / c->sample_rate; M_PI 69 doc/examples/resampling_audio.c const double c = 2 * M_PI * 440.0; M_PI 78 libavcodec/aacps_tablegen.h double theta = 2 * M_PI * (q + 0.5) * (n - 6) / bands; M_PI 111 libavcodec/aacps_tablegen.h 0, 0.35685527, 0.57133466, 0.92614472, 1.1943263, M_PI/2, 2.2006171, M_PI M_PI 166 libavcodec/aacps_tablegen.h if (alpha < 0) alpha += M_PI/2; M_PI 186 libavcodec/aacps_tablegen.h theta = -M_PI * fractional_delay_links[m] * f_center; M_PI 190 libavcodec/aacps_tablegen.h theta = -M_PI*fractional_delay_gain*f_center; M_PI 201 libavcodec/aacps_tablegen.h theta = -M_PI * fractional_delay_links[m] * f_center; M_PI 205 libavcodec/aacps_tablegen.h theta = -M_PI*fractional_delay_gain*f_center; M_PI 30 libavcodec/adx.c a = M_SQRT2 - cos(2.0 * M_PI * cutoff / sample_rate); M_PI 179 libavcodec/atrac3.c float wi = sin(((i + 0.5) / 256.0 - 0.5) * M_PI) + 1.0; M_PI 180 libavcodec/atrac3.c float wj = sin(((j + 0.5) / 256.0 - 0.5) * M_PI) + 1.0; M_PI 88 libavcodec/atrac3plusdsp.c #define TWOPI (2 * M_PI) M_PI 168 libavcodec/dcaenc.c cos_table[i] = (int32_t)(0x7fffffff * cos(M_PI * i / 1024)); M_PI 201 libavcodec/dcaenc.c accum += reconst * cos(2 * M_PI * (i + 0.5 - 256) * (j + 0.5) / 512); M_PI 209 libavcodec/dcaenc.c accum += reconst * cos(2 * M_PI * (i + 0.5 - 256) * (j + 0.5) / 512); M_PI 296 libavcodec/dct-test.c c8[i][j] = s * cos(M_PI * i * (j + 0.5) / 8.0); M_PI 305 libavcodec/dct-test.c c4[i][j] = s * cos(M_PI * i * (j + 0.5) / 4.0); M_PI 201 libavcodec/dct.c s->csc2[i] = 0.5 / sin((M_PI / (2 * n) * (2 * i + 1))); M_PI 48 libavcodec/dctref.c coefficients[i + j] = 0.5 * cos(i * (j + 0.5) * M_PI / 64.0); M_PI 36 libavcodec/evrcdec.c #define MIN_LSP_SEP (0.05 / (2.0 * M_PI)) M_PI 254 libavcodec/evrcdec.c float arg1 = M_PI * 0.9 * (tt - n); M_PI 255 libavcodec/evrcdec.c float arg2 = M_PI * (tt - n); M_PI 85 libavcodec/fft-test.c double alpha = 2 * M_PI * (float) i / (float) n; M_PI 131 libavcodec/fft-test.c double f = cos(M_PI * a / (double) (2 * n)); M_PI 147 libavcodec/fft-test.c double a = (2 * M_PI * (2 * i + 1 + n / 2) * (2 * k + 1) / (4 * n)); M_PI 165 libavcodec/fft-test.c double a = M_PI * k * (i + 0.5) / n; M_PI 180 libavcodec/fft-test.c double a = M_PI * k * (i + 0.5) / n; M_PI 93 libavcodec/fft_template.c double freq = 2*M_PI/m; M_PI 337 libavcodec/ffwavesynth.c ws->sin[i] = floor(32767 * sin(2 * M_PI * i / (1 << SIN_BITS))); M_PI 73 libavcodec/iirfilter.c wa = 2 * tan(M_PI * 0.5 * cutoff_ratio); M_PI 85 libavcodec/iirfilter.c double th = (i + (order >> 1) + 0.5) * M_PI / order; M_PI 136 libavcodec/iirfilter.c cos_w0 = cos(M_PI * cutoff_ratio); M_PI 137 libavcodec/iirfilter.c sin_w0 = sin(M_PI * cutoff_ratio); M_PI 343 libavcodec/iirfilter.c x[i] = lrint(0.75 * INT16_MAX * sin(0.5*M_PI*i*i/SIZE)); M_PI 214 libavcodec/imc.c q->post_cos[i] = (1.0f / 32768) * cos(i / 256.0 * M_PI); M_PI 215 libavcodec/imc.c q->post_sin[i] = (1.0f / 32768) * sin(i / 256.0 * M_PI); M_PI 217 libavcodec/imc.c r1 = sin((i * 4.0 + 1.0) / 1024.0 * M_PI); M_PI 218 libavcodec/imc.c r2 = cos((i * 4.0 + 1.0) / 1024.0 * M_PI); M_PI 117 libavcodec/imdct15.c s->twiddle_exptab[i].re = cos(2 * M_PI * (i + 0.125 + s->len4) / len); M_PI 118 libavcodec/imdct15.c s->twiddle_exptab[i].im = sin(2 * M_PI * (i + 0.125 + s->len4) / len); M_PI 128 libavcodec/imdct15.c s->exptab[i][j].re = cos(2 * M_PI * j / N); M_PI 129 libavcodec/imdct15.c s->exptab[i][j].im = sin(2 * M_PI * j / N); M_PI 31 libavcodec/kbdwin.c double alpha2 = (alpha * M_PI / n) * (alpha * M_PI / n); M_PI 98 libavcodec/lsp.c lsp[i] = cos(2.0 * M_PI * lsf[i]); M_PI 83 libavcodec/mdct_template.c alpha = 2 * M_PI * (i + theta) / n; M_PI 362 libavcodec/mpegaudiodec_template.c f = tan((double)i * M_PI / 12.0); M_PI 235 libavcodec/mpegaudiodsp_template.c d = sin(M_PI * (i + 0.5) / 36.0); M_PI 238 libavcodec/mpegaudiodsp_template.c else if (i >= 24) d = sin(M_PI * (i - 18 + 0.5) / 12.0); M_PI 242 libavcodec/mpegaudiodsp_template.c else if (i < 12) d = sin(M_PI * (i - 6 + 0.5) / 12.0); M_PI 246 libavcodec/mpegaudiodsp_template.c d *= 0.5 * IMDCT_SCALAR / cos(M_PI * (2 * i + 19) / 72); M_PI 4085 libavcodec/mpegvideo_enc.c basis[perm_index][8*x + y]= lrintf(s * cos((M_PI/8.0)*i*(x+0.5)) * cos((M_PI/8.0)*j*(y+0.5))); M_PI 1040 libavcodec/opus_celt.c theta = M_PI * gain * gain / 4; M_PI 543 libavcodec/qcelpdec.c lsp[i] = cos(M_PI * lspf[i]); M_PI 1416 libavcodec/qdm2.c const double iscale = 2.0 * M_PI / 512.0; M_PI 1460 libavcodec/qdm2.c const double iscale = 0.25 * M_PI; M_PI 370 libavcodec/ratecontrol.c M_PI, M_PI 119 libavcodec/rdft.c const double theta = (trans == DFT_R2C || trans == DFT_C2R ? -1 : 1) * 2 * M_PI / n; M_PI 118 libavcodec/resample2.c x = M_PI * ((double)(i - center) - (double)ph / phase_count) * factor; M_PI 129 libavcodec/resample2.c w = 2.0*x / (factor*tap_count) + M_PI; M_PI 133 libavcodec/resample2.c w = 2.0*x / (factor*tap_count*M_PI); M_PI 161 libavcodec/resample2.c sine[j]= cos(i*j*M_PI/LEN); M_PI 57 libavcodec/sinewin_tablegen.h window[i] = sinf((i + 0.5) * (M_PI / (2.0 * n))); M_PI 169 libavcodec/sipr.c lsfnew[9] = FFMIN(lsfnew[LP_FILTER_ORDER - 1], 1.3 * M_PI); M_PI 175 libavcodec/sipr.c lsfnew[LP_FILTER_ORDER - 1] *= 6.153848 / M_PI; M_PI 510 libavcodec/sipr.c ctx->lsp_history[i] = cos((i+1) * M_PI / (LP_FILTER_ORDER + 1)); M_PI 36 libavcodec/sipr.h #define LSFQ_DIFF_MIN (0.0125 * M_PI) M_PI 276 libavcodec/sipr16k.c ctx->lsp_history_16k[i] = cos((i + 1) * M_PI/(LP_FILTER_ORDER_16k + 1)); M_PI 564 libavcodec/twinvq.c double freq = 2 * M_PI / m; M_PI 1141 libavcodec/vorbisdec.c float wstep = M_PI / vf->bark_map_size; M_PI 159 libavcodec/wmadec.c wdel = M_PI / frame_len; M_PI 487 libavcodec/wmaprodec.c sin64[i] = sin(i*M_PI / 64.0); M_PI 400 libavcodec/wmavoice.c s->prev_lsps[n] = M_PI * (n + 1.0) / (s->lsps + 1.0); M_PI 603 libavcodec/wmavoice.c angle_mul = gain_mul * (8.0 * M_LN10 / M_PI); M_PI 866 libavcodec/wmavoice.c M_PI * -2.15522e-1, M_PI * -6.1646e-2, M_PI 867 libavcodec/wmavoice.c M_PI * -3.3486e-2, M_PI * -5.7408e-2 M_PI 893 libavcodec/wmavoice.c M_PI * -1.07448e-1, M_PI * -5.2706e-2, M_PI * -5.1634e-2 M_PI 929 libavcodec/wmavoice.c M_PI * -1.27576e-1, M_PI * -2.4292e-2, M_PI 930 libavcodec/wmavoice.c M_PI * -1.28094e-1, M_PI * -3.2128e-2, M_PI 931 libavcodec/wmavoice.c M_PI * -1.29816e-1 M_PI 962 libavcodec/wmavoice.c M_PI * -5.5830e-2, M_PI * -5.2908e-2, M_PI * -5.4776e-2 M_PI 1634 libavcodec/wmavoice.c lsps[0] = FFMAX(lsps[0], 0.0015 * M_PI); M_PI 1636 libavcodec/wmavoice.c lsps[n] = FFMAX(lsps[n], lsps[n - 1] + 0.0125 * M_PI); M_PI 1637 libavcodec/wmavoice.c lsps[num - 1] = FFMIN(lsps[num - 1], 0.9985 * M_PI); M_PI 2044 libavcodec/wmavoice.c s->prev_lsps[n] = M_PI * (n + 1.0) / (s->lsps + 1.0); M_PI 51 libavdevice/timefilter.c double o = 2 * M_PI * bandwidth * period * time_base; M_PI 128 libavfilter/af_afade.c gain = sin(gain * M_PI / 2.0); M_PI 131 libavfilter/af_afade.c gain = 1.0 - cos(M_PI / 4.0 * (pow(2.0*gain - 1, 3) + 1)); M_PI 134 libavfilter/af_afade.c gain = (1.0 - cos(gain * M_PI)) / 2.0; M_PI 215 libavfilter/af_aphaser.c 1., p->delay_buffer_length, M_PI / 2.0); M_PI 314 libavfilter/af_atempo.c double h = 0.5 * (1.0 - cos(2.0 * M_PI * t)); M_PI 239 libavfilter/af_biquads.c double w0 = 2 * M_PI * s->frequency / inlink->sample_rate; M_PI 242 libavfilter/af_biquads.c if (w0 > M_PI) { M_PI 433 libavfilter/avf_showcqt.c sv_step = sv = sin(2.0*M_PI*freq*(1.0/rate)); M_PI 434 libavfilter/avf_showcqt.c cv_step = cv = cos(2.0*M_PI*freq*(1.0/rate)); M_PI 436 libavfilter/avf_showcqt.c sw_step = sw = sin(2.0*M_PI*(1.0/tlen)); M_PI 437 libavfilter/avf_showcqt.c cw_step = cw = cos(2.0*M_PI*(1.0/tlen)); M_PI 223 libavfilter/avf_showspectrum.c s->window_func_lut[i] = .5f * (1 - cos(2*M_PI*i / (win_size-1))); M_PI 227 libavfilter/avf_showspectrum.c s->window_func_lut[i] = .54f - .46f * cos(2*M_PI*i / (win_size-1)); M_PI 231 libavfilter/avf_showspectrum.c s->window_func_lut[i] = .42f - .5f*cos(2*M_PI*i / (win_size-1)) + .08f*cos(4*M_PI*i / (win_size-1)); M_PI 358 libavfilter/avf_showspectrum.c uf = yf * M_PI; M_PI 359 libavfilter/avf_showspectrum.c vf = yf * M_PI; M_PI 377 libavfilter/avf_showspectrum.c uf *= 0.5 * sin((2 * M_PI * ch) / s->nb_display_channels); M_PI 378 libavfilter/avf_showspectrum.c vf *= 0.5 * cos((2 * M_PI * ch) / s->nb_display_channels); M_PI 29 libavfilter/generate_wave_table.c uint32_t i, phase_offset = phase / M_PI / 2 * table_size + 0.5; M_PI 37 libavfilter/generate_wave_table.c d = (sin((double)point / table_size * 2 * M_PI) + 1) / 2; M_PI 226 libavfilter/vf_deshake.c return (diff > M_PI) ? diff - 2 * M_PI : M_PI 227 libavfilter/vf_deshake.c (diff < -M_PI) ? diff + 2 * M_PI : M_PI 349 libavfilter/vf_hue.c hue->hue = hue->hue_deg * M_PI / 180; M_PI 352 libavfilter/vf_hue.c hue->hue_deg = hue->hue * 180 / M_PI; M_PI 357 libavfilter/vf_hue.c hue->hue/M_PI, hue->hue_deg, hue->saturation, hue->brightness, M_PI 396 libavfilter/vf_rotate.c } else if (fabs(rot->angle - M_PI/2) < FLT_EPSILON && outw == inh && outh == inw) { M_PI 400 libavfilter/vf_rotate.c } else if (fabs(rot->angle - M_PI) < FLT_EPSILON && outw == inw && outh == inh) { M_PI 404 libavfilter/vf_rotate.c } else if (fabs(rot->angle - 3*M_PI/2) < FLT_EPSILON && outw == inh && outh == inw) { M_PI 481 libavfilter/vf_rotate.c rot->var_values[VAR_N], rot->var_values[VAR_T], rot->angle/M_PI); M_PI 345 libavfilter/vf_signalstats.c ((int16_t*)p_hue)[i] = floor((180 / M_PI) * atan2f(yuvu-128, yuvv-128) + 180); M_PI 97 libavfilter/vsrc_mptestsrc.c c[i*8+j] = s*cos((M_PI/8.0)*i*(j+0.5)); M_PI 100 libavresample/avresample-test.c a += M_PI * 1000.0 * 2.0 / sample_rate; M_PI 110 libavresample/avresample-test.c a += M_PI * f * 2.0 / sample_rate; M_PI 138 libavresample/avresample-test.c taba[ch] += M_PI * f * 2.0 / sample_rate; M_PI 152 libavresample/avresample-test.c a += M_PI * 500.0 * 2.0 / sample_rate; M_PI 153 libavresample/avresample-test.c ampa += M_PI * 2.0 / sample_rate; M_PI 83 libavresample/resample.c x = M_PI * ((double)(i - center) - (double)ph / phase_count) * factor; M_PI 95 libavresample/resample.c w = 2.0 * x / (factor * tap_count) + M_PI; M_PI 101 libavresample/resample.c w = 2.0 * x / (factor * tap_count * M_PI); M_PI 45 libavutil/display.c CONV_FP(matrix[0]) / scale[0]) * 180 / M_PI; M_PI 52 libavutil/display.c double radians = angle * M_PI / 180.0f; M_PI 87 libavutil/eval.c { "PI", M_PI }, M_PI 178 libavutil/eval.c case e_gauss: { double d = eval_expr(p, e->param[0]); return exp(-d*d/2)/sqrt(2*M_PI); } M_PI 735 libavutil/eval.c M_PI, M_PI 45 libavutil/mathematics.h #ifndef M_PI M_PI 87 libswresample/resample.c x = M_PI * ((double)(i - center) - (double)ph / phase_count) * factor; M_PI 98 libswresample/resample.c w = 2.0*x / (factor*tap_count) + M_PI; M_PI 102 libswresample/resample.c w = 2.0*x / (factor*tap_count*M_PI); M_PI 143 libswresample/resample.c sine[j]= cos(i*j*M_PI/LEN); M_PI 166 libswresample/swresample-test.c a += M_PI * 1000.0 * 2.0 / sample_rate; M_PI 176 libswresample/swresample-test.c a += M_PI * f * 2.0 / sample_rate; M_PI 204 libswresample/swresample-test.c taba[ch] += M_PI * f * 2.0 / sample_rate; M_PI 218 libswresample/swresample-test.c a += M_PI * 500.0 * 2.0 / sample_rate; M_PI 219 libswresample/swresample-test.c ampa += M_PI * 2.0 / sample_rate; M_PI 420 libswscale/utils.c coeff = d ? sin(d * M_PI) / (d * M_PI) : 1.0; M_PI 429 libswscale/utils.c c = cos(floatd * M_PI); M_PI 450 libswscale/utils.c coeff = (d ? sin(floatd * M_PI) / (floatd * M_PI) : 1.0) * fone; M_PI 453 libswscale/utils.c coeff = (d ? sin(floatd * M_PI) * sin(floatd * M_PI / p) / M_PI 454 libswscale/utils.c (floatd * floatd * M_PI * M_PI / p) : 1.0) * fone; M_PI 1692 libswscale/utils.c sqrt(2 * variance * M_PI);