Searched refs:y0 (Results 26 - 50 of 431) sorted by relevance

1234567891011>>

/external/skia/src/core/
H A DSkEdge.h16 // This correctly favors the lower-pixel when y0 is on a 1/2 pixel boundary
17 #define SkEdge_Compute_DY(top, y0) (SkLeftShift(top, 6) + 32 - (y0))
89 SkFDot6 x0, y0, x1, y1;
94 y0 = SkScalarRoundToFDot6(p0.fY, shift);
100 y0 = int(p0.fY * scale);
108 if (y0 > y1) {
110 SkTSwap(y0, y1);
114 int top = SkFDot6Round(y0);
122 SkFixed slope = SkFDot6Div(x1 - x0, y1 - y0);
[all...]
H A DSkAnalyticEdge.h144 SkFixed y0 = SnapY(SkFDot6ToFixed(SkScalarRoundToFDot6(p0.fY, accuracy)) >> accuracy);
150 SkFixed y0 = SnapY(SkFDot6ToFixed(SkScalarToFDot6(p0.fY * multiplier)) >> accuracy);
157 if (y0 > y1) {
159 SkTSwap(y0, y1);
164 SkFDot6 dy = SkFixedToFDot6(y1 - y0);
175 fY = y0;
176 fUpperY = y0;
195 static inline bool IsEmpty(SkScalar y0, SkScalar y1, int shift = 2) {
197 return SkScalarRoundToFDot6(y0, shift) == SkScalarRoundToFDot6(y1, shift);
200 return SkFDot6Round(int(y0 * scal
[all...]
/external/skqp/src/core/
H A DSkEdge.h16 // This correctly favors the lower-pixel when y0 is on a 1/2 pixel boundary
17 #define SkEdge_Compute_DY(top, y0) (SkLeftShift(top, 6) + 32 - (y0))
89 SkFDot6 x0, y0, x1, y1;
94 y0 = SkScalarRoundToFDot6(p0.fY, shift);
100 y0 = int(p0.fY * scale);
108 if (y0 > y1) {
110 SkTSwap(y0, y1);
114 int top = SkFDot6Round(y0);
122 SkFixed slope = SkFDot6Div(x1 - x0, y1 - y0);
[all...]
/external/swiftshader/src/OpenGL/libGLESv2/
H A DDevice.cpp209 clearRect.clip(scissorRect.x0, scissorRect.y0, scissorRect.x1, scissorRect.y1);
229 clearRect.clip(scissorRect.x0, scissorRect.y0, scissorRect.x1, scissorRect.y1);
232 depthBuffer->clearDepth(z, clearRect.x0, clearRect.y0, clearRect.width(), clearRect.height());
246 clearRect.clip(scissorRect.x0, scissorRect.y0, scissorRect.x1, scissorRect.y1);
249 stencilBuffer->clearStencil(stencil, mask, clearRect.x0, clearRect.y0, clearRect.width(), clearRect.height());
460 flipY = (sourceRect->y0 < sourceRect->y1) ^ (destRect->y0 < destRect->y1);
465 flipY = (sourceRect->y0 > sourceRect->y1);
470 flipY = (destRect->y0 > destRect->y1);
480 sRect.y0
[all...]
/external/apache-commons-math/src/main/java/org/apache/commons/math/ode/nonstiff/
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 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 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 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...]
/external/libvpx/libvpx/vp8/encoder/x86/
H A Dvp8_quantize_ssse3.c53 __m128i sz0, sz1, x, x0, x1, y0, y1, zeros, abs0, abs1; local
73 y0 = _mm_mulhi_epi16(x0, quant_fast0);
79 abs0 = y0;
83 y0 = _mm_xor_si128(y0, sz0);
85 x0 = _mm_sub_epi16(y0, sz0);
/external/clang/test/CXX/temp/temp.spec/
H A Dno-body.cpp53 template<typename T> struct y0 { }; struct
60 template struct y0 { }; // expected-error {{class cannot be defined in an explicit instantiation; if this declaration is meant to be a class definition, remove the 'template' keyword}} struct in namespace:noargs_body
/external/pdfium/core/fpdfapi/page/
H A Dcpdf_page.cpp133 float y0 = 0; local
142 y0 = yPos + ySize;
150 y0 = yPos;
158 y0 = yPos;
166 y0 = yPos + ySize;
174 matrix.Concat(CFX_Matrix((x2 - x0) / m_PageWidth, (y2 - y0) / m_PageWidth,
175 (x1 - x0) / m_PageHeight, (y1 - y0) / m_PageHeight,
176 x0, y0));
/external/tensorflow/tensorflow/contrib/integrate/python/ops/
H A Dodes_test.py40 self.y0 = np.array([[1.0], [0.0]])
47 y0 = constant_op.constant(1.0, dtype=dtypes.float64)
49 y_solved = odes.odeint(func, y0, t)
95 y0 = constant_op.constant([[0.0], [1.0]], dtype=dtypes.float64)
98 y_solved = odes.odeint(func, y0, t)
109 y0 = constant_op.constant(1.0, dtype=dtypes.float64)
113 y_solved = odes.odeint(func, array_ops.reshape(y0, shape), t)
127 y0 = math_ops.cast(1.0, y0_dtype)
128 y_solved = odes.odeint(func, y0, math_ops.cast(t, t_dtype))
136 with self.assertRaisesRegexp(TypeError, '`y0` mus
[all...]
/external/dng_sdk/source/
H A Ddng_1d_function.cpp45 real64 y0 = Evaluate (x0); local
53 if (Abs_real64 (y1 - y0) < kNearZero)
59 x1 + (y - y1) * (x1 - x0) / (y1 - y0),
65 y0 = y1;
/external/valgrind/memcheck/tests/amd64-solaris/
H A Dcontext_gpr.c38 long y0; local
46 y0 = py[0];
64 "movq %[y0], %%rbx\n"
77 : [y0] "m" (y0)
H A Dcontext_sse.c37 upad128_t y0; local
52 y0 = py[0];
69 "movups %[y0], %%xmm0\n"
72 "movups %[y0], %%xmm3\n"
73 "movups %[y0], %%xmm4\n"
76 "movups %[y0], %%xmm7\n"
89 : "a" (SYS_kill), "D" (pid), "S" (SIGUSR1), [y0] "m" (y0), [d0] "m" (d0)
/external/valgrind/memcheck/tests/x86-solaris/
H A Dcontext_gpr.c32 int y0; local
40 y0 = py[0];
57 "movl %[y0], %%ebx\n"
75 [y0] "m" (y0)
H A Dcontext_sse.c35 upad128_t y0; local
50 y0 = py[0];
67 "movups %[y0], %%xmm0\n"
70 "movups %[y0], %%xmm3\n"
71 "movups %[y0], %%xmm4\n"
74 "movups %[y0], %%xmm7\n"
95 [y0] "m" (y0), [d0] "m" (d0)
/external/swiftshader/src/OpenGL/libGLES_CM/
H A DDevice.cpp179 clearRect.clip(scissorRect.x0, scissorRect.y0, scissorRect.x1, scissorRect.y1);
197 clearRect.clip(scissorRect.x0, scissorRect.y0, scissorRect.x1, scissorRect.y1);
200 depthBuffer->clearDepth(z, clearRect.x0, clearRect.y0, clearRect.width(), clearRect.height());
214 clearRect.clip(scissorRect.x0, scissorRect.y0, scissorRect.x1, scissorRect.y1);
217 stencilBuffer->clearStencil(stencil, mask, clearRect.x0, clearRect.y0, clearRect.width(), clearRect.height());
340 sRect.y0 = 0;
352 dRect.y0 = 0;
358 bool scaling = (sRect.x1 - sRect.x0 != dRect.x1 - dRect.x0) || (sRect.y1 - sRect.y0 != dRect.y1 - dRect.y0);
416 unsigned char *sourceBytes = (unsigned char*)source->lockInternal(sRect.x0, sRect.y0, sRec
[all...]
/external/mesa3d/src/gallium/drivers/llvmpipe/
H A Dlp_setup_point.c123 float y0 = info->v0[0][1] - setup->pixel_offset; local
127 info->a0[slot][0] = 0.5 - (dadx * x0 + dady * y0);
139 float y0 = info->v0[0][1] - setup->pixel_offset; local
147 info->a0[slot][1] = 0.5 - (dadx * x0 + dady * y0);
371 int x0, y0; local
378 y0 = subpixel_snap(v0[0][1] - setup->pixel_offset) - fixed_width/2;
382 bbox.y0 = (y0 + (FIXED_ONE-1) + adj) >> FIXED_ORDER;
383 bbox.y1 = (y0 + fixed_width + (FIXED_ONE-1) + adj) >> FIXED_ORDER;
400 const int y0 local
[all...]
/external/mesa3d/src/gallium/auxiliary/util/
H A Du_format_yuv.c492 uint8_t y0, y1, u, v; local
498 y0 = (value >> 8) & 0xff;
502 util_format_yuv_to_rgb_float(y0, u, v, &dst[0], &dst[1], &dst[2]);
515 y0 = (value >> 8) & 0xff;
519 util_format_yuv_to_rgb_float(y0, u, v, &dst[0], &dst[1], &dst[2]);
540 uint8_t y0, y1, u, v; local
546 y0 = (value >> 8) & 0xff;
550 util_format_yuv_to_rgb_8unorm(y0, u, v, &dst[0], &dst[1], &dst[2]);
563 y0 = (value >> 8) & 0xff;
567 util_format_yuv_to_rgb_8unorm(y0,
587 uint8_t y0, y1, u, v; local
591 uint8_t y0, y1, u0, u1, v0, v1, u, v; local
640 uint8_t y0, y1, u, v; local
644 uint8_t y0, y1, u0, u1, v0, v1, u, v; local
713 uint8_t y0, y1, u, v; local
761 uint8_t y0, y1, u, v; local
808 uint8_t y0, y1, u, v; local
812 uint8_t y0, y1, u0, u1, v0, v1, u, v; local
861 uint8_t y0, y1, u, v; local
865 uint8_t y0, y1, u0, u1, v0, v1, u, v; local
[all...]
/external/libldac/src/
H A Dsigana_ldac.c37 SCALAR y0, y1, y2; local
48 y0 = y1;
51 tmp = y1 * y1 + (y0-y2) * (y0-y2);
57 y0 = y1;
60 tmp = y1 * y1 + (y0-y2) * (y0-y2);
/external/mesa3d/src/mesa/program/
H A Dprog_noise.c257 float y0 = y - Y0; local
266 if (x0 > y0) {
280 y1 = y0 - j1 + G2;
282 y2 = y0 - 1.0f + 2.0f * G2;
289 t0 = 0.5f - x0 * x0 - y0 * y0;
294 n0 = t0 * t0 * grad2(perm[ii + perm[jj]], x0, y0);
343 float y0 = y - Y0; local
356 if (x0 >= y0) {
357 if (y0 >
504 float y0 = y - Y0; local
[all...]
/external/mesa3d/src/mesa/swrast/
H A Ds_linetemp.h73 GLint y0 = (GLint) vert0->attrib[VARYING_SLOT_POS][1]; local
142 if ((y0==h) | (y1==h)) {
143 if ((y0==h) & (y1==h))
145 y0 -= y0==h;
152 dy = y1 - y0;
169 zPtr = (DEPTH_TYPE *) _swrast_pixel_address(zrb, x0, y0);
172 pixelPtr = (PIXEL_TYPE *) PIXEL_ADDRESS(x0,y0);
313 PLOT( x0, y0 );
316 span.array->y[i] = y0;
[all...]
/external/pdfium/third_party/libopenjpeg20/
H A Dsparse_array.c97 OPJ_UINT32 y0,
102 y0 >= sa->height || y1 <= y0 || y1 > sa->height);
108 OPJ_UINT32 y0,
121 if (!opj_sparse_array_is_region_valid(sa, x0, y0, x1, y1)) {
125 block_y = y0 / sa->block_height;
126 for (y = y0; y < y1; block_y ++, y += y_incr) {
130 y_incr = (y == y0) ? sa->block_height - (y0 % sa->block_height) :
146 OPJ_INT32* dest_ptr = buf + (y - y0) * (OPJ_SIZE_
95 opj_sparse_array_is_region_valid(const opj_sparse_array_int32_t* sa, OPJ_UINT32 x0, OPJ_UINT32 y0, OPJ_UINT32 x1, OPJ_UINT32 y1) argument
105 opj_sparse_array_int32_read_or_write( const opj_sparse_array_int32_t* sa, OPJ_UINT32 x0, OPJ_UINT32 y0, OPJ_UINT32 x1, OPJ_UINT32 y1, OPJ_INT32* buf, OPJ_UINT32 buf_col_stride, OPJ_UINT32 buf_line_stride, OPJ_BOOL forgiving, OPJ_BOOL is_read_op) argument
311 opj_sparse_array_int32_read(const opj_sparse_array_int32_t* sa, OPJ_UINT32 x0, OPJ_UINT32 y0, OPJ_UINT32 x1, OPJ_UINT32 y1, OPJ_INT32* dest, OPJ_UINT32 dest_col_stride, OPJ_UINT32 dest_line_stride, OPJ_BOOL forgiving) argument
330 opj_sparse_array_int32_write(opj_sparse_array_int32_t* sa, OPJ_UINT32 x0, OPJ_UINT32 y0, OPJ_UINT32 x1, OPJ_UINT32 y1, const OPJ_INT32* src, OPJ_UINT32 src_col_stride, OPJ_UINT32 src_line_stride, OPJ_BOOL forgiving) argument
[all...]
/external/swiftshader/src/OpenGL/libGL/
H A DDevice.cpp208 clearRect.clip(scissorRect.x0, scissorRect.y0, scissorRect.x1, scissorRect.y1);
232 clearRect.clip(scissorRect.x0, scissorRect.y0, scissorRect.x1, scissorRect.y1);
235 depthStencil->clearDepth(z, clearRect.x0, clearRect.y0, clearRect.width(), clearRect.height());
249 clearRect.clip(scissorRect.x0, scissorRect.y0, scissorRect.x1, scissorRect.y1);
252 depthStencil->clearStencil(stencil, mask, clearRect.x0, clearRect.y0, clearRect.width(), clearRect.height());
518 sRect.y0 = 0;
530 dRect.y0 = 0;
536 bool scaling = (sRect.x1 - sRect.x0 != dRect.x1 - dRect.x0) || (sRect.y1 - sRect.y0 != dRect.y1 - dRect.y0);
594 unsigned char *sourceBytes = (unsigned char*)source->lockInternal(sRect.x0, sRect.y0, sRec
[all...]

Completed in 1406 milliseconds

1234567891011>>