Searched refs:y0 (Results 1 - 25 of 431) sorted by path

1234567891011>>

/external/ImageMagick/coders/
H A Djp2.c959 jp2_image->y0=parameters.image_offset_y0;
/external/aac/libAACdec/src/
H A Dusacdec_lpc.cpp232 int i, y0[8], y1[8]; local
236 /* find the nearest neighbor y0 of x in 2D8 */
237 nearest_neighbor_2D8(x, y0);
247 /* compute e0=||x-y0||^2 and e1=||x-y1||^2 */
250 tmp = x[i] - INT2ZF(y0[i], 0);
256 /* select best candidate y0 or y1 to minimize distortion */
259 y[i] = y0[i];
/external/aac/libFDK/src/
H A Dqmf.cpp336 FIXP_DBL x0, x1, y0, y1; local
340 y0 = timeIn[L2 - 1 - i];
343 rSubband[i + 0] = x0 - (y0 >> 1);
345 iSubband[i + 0] = x0 + (y0 >> 1);
/external/adhd/cras/src/dsp/
H A Ddrc_kernel.c199 float y0 = knee_curve(dk, dk->knee_threshold, k); local
200 dk->ratio_base = y0 * powf(dk->knee_threshold, -dk->slope);
230 * log(y/y0) = s * log(x/x0)
231 * => y = y0 * (x/x0)^s
232 * => y = [y0 * (1/x0)^s] * x^s
/external/apache-commons-math/src/main/java/org/apache/commons/math/analysis/solvers/
H A DBrentSolver.java292 * @param y0 function value at the approximation for the root
304 double x0, double y0,
319 y0 = y1;
321 y2 = y0;
338 (FastMath.abs(y0) <= FastMath.abs(y1))) {
343 double r3 = y1 / y0;
355 double r1 = y0 / y2;
379 y0 = y1;
391 y2 = y0;
303 solve(final UnivariateRealFunction f, double x0, double y0, double x1, double y1, double x2, double y2) argument
H A DMullerSolver.java206 double y0 = f.value(x0);
213 if (y0 == 0.0) {
227 final double d01 = (y1 - y0) / (x1 - x0);
260 y0 = x < x1 ? y0 : y1;
268 if (MathUtils.sign(y0) + MathUtils.sign(ym) == 0.0) {
271 x0 = xm; y0 = ym;
349 double y0 = f.value(x0);
356 if (y0 == 0.0) { return min; }
364 final double a = q * (y2 - (1 + q) * y1 + q * y0);
[all...]
H A DSecantSolver.java172 double y0 = f.value(x0);
176 if (y0 * y1 >= 0) {
178 LocalizedFormats.SAME_SIGN_AT_ENDPOINTS, min, max, y0, y1);
182 double y2 = y0;
190 y0 = y1;
192 y2 = y0;
204 if (FastMath.abs(y1) > FastMath.abs(y0)) {
208 delta = (x0 - x1) / (1 - y0 / y1);
216 y0 = y1;
222 y2 = y0;
[all...]
/external/apache-commons-math/src/main/java/org/apache/commons/math/ode/
H A DAbstractIntegrator.java351 * @param y0 state vector at t0
357 final double t0, final double[] y0,
361 if (ode.getDimension() != y0.length) {
363 LocalizedFormats.DIMENSIONS_MISMATCH_SIMPLE, ode.getDimension(), y0.length);
356 sanityChecks(final FirstOrderDifferentialEquations ode, final double t0, final double[] y0, final double t, final double[] y) argument
H A DFirstOrderIntegrator.java45 * @param y0 initial value of the state vector at t0
49 * step (and hence at the end of integration), can be the same object as y0
58 double t0, double[] y0,
57 integrate(FirstOrderDifferentialEquations equations, double t0, double[] y0, double t, double[] y) argument
H A DMultistepIntegrator.java205 * @param y0 initial value of the state vector at t0
212 protected void start(final double t0, final double[] y0, final double t) argument
222 starter.addStepHandler(new NordsieckInitializer(y0.length));
226 starter.integrate(new CountingDifferentialEquations(y0.length),
227 t0, y0, t, new double[y0.length]);
H A DSecondOrderIntegrator.java41 * @param y0 initial value of the state vector at t0
48 * same object as y0
56 double t0, double[] y0, double[] yDot0,
55 integrate(SecondOrderDifferentialEquations equations, double t0, double[] y0, double[] yDot0, double t, double[] y, double[] yDot) argument
/external/apache-commons-math/src/main/java/org/apache/commons/math/ode/jacobians/
H A DFirstOrderIntegratorWithJacobians.java196 * @param y0 initial value of the state vector at t0
202 * step (and hence at the end of integration), can be the same object as y0
215 public double integrate(final double t0, final double[] y0, final double[][] dY0dP, argument
222 checkDimension(n, y0);
235 // with respect to initial state y0 and to parameters p
240 System.arraycopy(y0, 0, z, 0, n);
/external/apache-commons-math/src/main/java/org/apache/commons/math/ode/nonstiff/
H A DAdamsBashforthIntegrator.java189 final double t0, final double[] y0,
193 final int n = y0.length;
194 sanityChecks(equations, t0, y0, t, y);
200 if (y != y0) {
201 System.arraycopy(y0, 0, y, 0, n);
259 System.arraycopy(interpolator.getInterpolatedState(), 0, y, 0, y0.length);
265 final double[] predictedScaled = new double[y0.length];
266 for (int j = 0; j < y0.length; ++j) {
188 integrate(final FirstOrderDifferentialEquations equations, final double t0, final double[] y0, final double t, final double[] y) argument
H A DAdamsIntegrator.java86 final double t0, final double[] y0,
85 integrate(final FirstOrderDifferentialEquations equations, final double t0, final double[] y0, final double t, final double[] y) argument
H A DAdamsMoultonIntegrator.java206 final double t0, final double[] y0,
210 final int n = y0.length;
211 sanityChecks(equations, t0, y0, t, y);
217 if (y != y0) {
218 System.arraycopy(y0, 0, y, 0, n);
220 final double[] yDot = new double[y0.length];
221 final double[] yTmp = new double[y0.length];
222 final double[] predictedScaled = new double[y0.length];
254 System.arraycopy(interpolator.getInterpolatedState(), 0, yTmp, 0, y0.length);
260 for (int j = 0; j < y0
205 integrate(final FirstOrderDifferentialEquations equations, final double t0, final double[] y0, final double t, final double[] y) argument
[all...]
H A DAdaptiveStepsizeIntegrator.java174 * @param y0 state vector at t0
181 final double t0, final double[] y0,
185 super.sanityChecks(equations, t0, y0, t, y);
211 * @param y0 state vector at t0
212 * @param yDot0 first time derivative of y0
221 final double t0, final double[] y0, final double[] yDot0,
236 ratio = y0[j] / scale[j];
249 for (int j = 0; j < y0.length; ++j) {
250 y1[j] = y0[j] + h * yDot0[j];
319 double t0, double[] y0,
180 sanityChecks(final FirstOrderDifferentialEquations equations, final double t0, final double[] y0, final double t, final double[] y) argument
219 initializeStep(final FirstOrderDifferentialEquations equations, final boolean forward, final int order, final double[] scale, final double t0, final double[] y0, final double[] yDot0, final double[] y1, final double[] yDot1) argument
318 integrate(FirstOrderDifferentialEquations equations, double t0, double[] y0, double t, double[] y) argument
[all...]
H A DDormandPrince54Integrator.java135 final double[] y0, final double[] y1,
145 final double yScale = FastMath.max(FastMath.abs(y0[j]), FastMath.abs(y1[j]));
134 estimateError(final double[][] yDotK, final double[] y0, final double[] y1, final double h) argument
H A DDormandPrince853Integrator.java249 final double[] y0, final double[] y1,
264 final double yScale = FastMath.max(FastMath.abs(y0[j]), FastMath.abs(y1[j]));
248 estimateError(final double[][] yDotK, final double[] y0, final double[] y1, final double h) argument
H A DEmbeddedRungeKuttaIntegrator.java193 final double t0, final double[] y0,
197 sanityChecks(equations, t0, y0, t, y);
204 if (y != y0) {
205 System.arraycopy(y0, 0, y, 0, y0.length);
207 final double[][] yDotK = new double[stages][y0.length];
208 final double[] yTmp = new double[y0.length];
209 final double[] yDotTmp = new double[y0.length];
267 for (int j = 0; j < y0.length; ++j) {
280 for (int j = 0; j < y0
192 integrate(final FirstOrderDifferentialEquations equations, final double t0, final double[] y0, final double t, final double[] y) argument
375 estimateError(double[][] yDotK, double[] y0, double[] y1, double h) argument
[all...]
H A DGraggBulirschStoerIntegrator.java445 * @param y0 initial value of the state vector at t0
459 private boolean tryStep(final double t0, final double[] y0, final double step, final int k, argument
471 for (int i = 0; i < y0.length; ++i) {
472 yTmp[i] = y0[i];
473 yEnd[i] = y0[i] + subStep * f[0][i];
482 System.arraycopy(yEnd, 0, yMiddle, 0, y0.length);
486 for (int i = 0; i < y0.length; ++i) {
514 for (int i = 0; i < y0.length; ++i) {
551 final double t0, final double[] y0, final double t, final double[] y)
554 sanityChecks(equations, t0, y0,
550 integrate(final FirstOrderDifferentialEquations equations, final double t0, final double[] y0, final double t, final double[] y) argument
[all...]
H A DHighamHall54Integrator.java108 final double[] y0, final double[] y1,
119 final double yScale = FastMath.max(FastMath.abs(y0[j]), FastMath.abs(y1[j]));
107 estimateError(final double[][] yDotK, final double[] y0, final double[] y1, final double h) argument
H A DRungeKuttaIntegrator.java96 final double t0, final double[] y0,
100 sanityChecks(equations, t0, y0, t, y);
107 if (y != y0) {
108 System.arraycopy(y0, 0, y, 0, y0.length);
112 yDotK [i] = new double[y0.length];
114 final double[] yTmp = new double[y0.length];
115 final double[] yDotTmp = new double[y0.length];
148 for (int j = 0; j < y0.length; ++j) {
161 for (int j = 0; j < y0
95 integrate(final FirstOrderDifferentialEquations equations, final double t0, final double[] y0, final double t, final double[] y) argument
[all...]
/external/autotest/client/site_tests/firmware_TouchMTB/
H A Dmtb.py575 def _calc_distance(self, (x0, y0), (x1, y1)):
578 dist_y = y1 - y0
/external/boringssl/src/crypto/fipsmodule/aes/asm/
H A Dbsaes-armv7.pl190 #;* Mul_GF4: Input x0-x1,y0-y1 Output x0-x1 Temp t0 (8) *
192 my ($x0,$x1,$y0,$y1,$t0,$t1)=@_;
194 veor $t0, $y0, $y1
197 vand $t1, $x1, $y0
206 my ($x0,$x1,$y0,$y1,$t0)=@_;
208 veor $t0, $y0, $y1
211 vand $x1, $x1, $y0
220 my ($x0,$x1,$y0,$y1,$t0,
223 veor $t0, $y0, $y1
229 vand $x1, $x1, $y0
[all...]
H A Dbsaes-x86_64.pl222 #;* Mul_GF4: Input x0-x1,y0-y1 Output x0-x1 Temp t0 (8) *
224 my ($x0,$x1,$y0,$y1,$t0)=@_;
226 movdqa $y0, $t0
230 pand $y0, $x1
239 my ($x0,$x1,$y0,$y1,$t0)=@_;
241 movdqa $y0, $t0
245 pand $y0, $x1
254 my ($x0,$x1,$y0,$y1,$t0,
257 movdqa $y0, $t0
265 pand $y0,
[all...]

Completed in 631 milliseconds

1234567891011>>