/external/rust/crates/libm/src/math/ |
D | rem_pio2.rs | 57 let mut y0 = r - w; in rem_pio2() localVariable 58 let ui = f64::to_bits(y0); in rem_pio2() 67 y0 = r - w; in rem_pio2() 68 let ey = (f64::to_bits(y0) >> 52) as i32 & 0x7ff; in rem_pio2() 75 y0 = r - w; in rem_pio2() 78 let y1 = (r - y0) - w; in rem_pio2() 79 (n, y0, y1) in rem_pio2() 92 let y0 = z - PIO2_1T; in rem_pio2() localVariable 93 let y1 = (z - y0) - PIO2_1T; in rem_pio2() 94 return (1, y0, y1); in rem_pio2() [all …]
|
/external/fonttools/Lib/fontTools/pens/ |
D | momentsPen.py | 41 x0,y0 = self._getCurrentPoint() 44 r0 = x1*y0 48 r4 = 2*y0 49 r5 = y0 - y1 51 r7 = y0**2 55 r11 = y0**3 58 self.area += -r0/2 - r1/2 + x0*(y0 + y1)/2 59 self.momentX += -r2*y0/6 - r2*y1/3 + r3*(r4 + y1)/6 - r6*x1/6 60 self.momentY += -r0*y1/6 - r7*x1/6 - r8*x1/6 + x0*(r7 + r8 + y0*y1)/6 61 self.momentXX += -r2*r6/12 - r3*r5*x1/12 - r9*y0/12 - r9*y1/4 + x0**3*(3*y0 + y1)/12 [all …]
|
D | areaPen.py | 19 x0, y0 = self._p0 21 self.value -= (x1 - x0) * (y1 + y0) * .5 27 x0, y0 = p0[0], p0[1] 28 x1, y1 = p1[0] - x0, p1[1] - y0 29 x2, y2 = p2[0] - x0, p2[1] - y0 37 x0, y0 = p0[0], p0[1] 38 x1, y1 = p1[0] - x0, p1[1] - y0 39 x2, y2 = p2[0] - x0, p2[1] - y0 40 x3, y3 = p3[0] - x0, p3[1] - y0
|
/external/mesa3d/src/gallium/auxiliary/util/ |
D | u_rect.h | 41 int y0, y1; member 53 a->y1 < b->y0 || in u_rect_test_intersection() 54 b->y1 < a->y0 || in u_rect_test_intersection() 56 a->y1 < a->y0 || in u_rect_test_intersection() 58 b->y1 < b->y0)); in u_rect_test_intersection() 71 if (b->y0 < a->y0) b->y0 = a->y0; in u_rect_find_intersection() 79 return (r->x1 - r->x0) * (r->y1 - r->y0); in u_rect_area() 94 b->x0 = b->y0 = 0; in u_rect_possible_intersection() 105 d->y0 = MIN2(a->y0, b->y0); in u_rect_union()
|
/external/skqp/src/core/ |
D | SkEdge.cpp | 38 SkFDot6 x0, y0, x1, y1; in setLine() local 43 y0 = SkScalarRoundToFDot6(p0.fY, shift); in setLine() 49 y0 = int(p0.fY * scale); in setLine() 57 if (y0 > y1) { in setLine() 60 swap(y0, y1); in setLine() 64 int top = SkFDot6Round(y0); in setLine() 76 SkFixed slope = SkFDot6Div(x1 - x0, y1 - y0); in setLine() 77 const SkFDot6 dy = SkEdge_Compute_DY(top, y0); in setLine() 94 int SkEdge::updateLine(SkFixed x0, SkFixed y0, SkFixed x1, SkFixed y1) in updateLine() argument 100 y0 >>= 10; in updateLine() [all …]
|
D | SkEdge.h | 19 #define SkEdge_Compute_DY(top, y0) (SkLeftShift(top, 6) + 32 - (y0)) argument 91 SkFDot6 x0, y0, x1, y1; in setLine() local 96 y0 = SkScalarRoundToFDot6(p0.fY, shift); in setLine() 102 y0 = int(p0.fY * scale); in setLine() 110 if (y0 > y1) { in setLine() 113 swap(y0, y1); in setLine() 117 int top = SkFDot6Round(y0); in setLine() 125 SkFixed slope = SkFDot6Div(x1 - x0, y1 - y0); in setLine() 126 const SkFDot6 dy = SkEdge_Compute_DY(top, y0); in setLine()
|
/external/skia/src/core/ |
D | SkEdge.cpp | 38 SkFDot6 x0, y0, x1, y1; in setLine() local 43 y0 = SkScalarRoundToFDot6(p0.fY, shift); in setLine() 49 y0 = int(p0.fY * scale); in setLine() 57 if (y0 > y1) { in setLine() 60 swap(y0, y1); in setLine() 64 int top = SkFDot6Round(y0); in setLine() 76 SkFixed slope = SkFDot6Div(x1 - x0, y1 - y0); in setLine() 77 const SkFDot6 dy = SkEdge_Compute_DY(top, y0); in setLine() 94 int SkEdge::updateLine(SkFixed x0, SkFixed y0, SkFixed x1, SkFixed y1) in updateLine() argument 100 y0 >>= 10; in updateLine() [all …]
|
D | SkEdge.h | 19 #define SkEdge_Compute_DY(top, y0) (SkLeftShift(top, 6) + 32 - (y0)) argument 91 SkFDot6 x0, y0, x1, y1; in setLine() local 96 y0 = SkScalarRoundToFDot6(p0.fY, shift); in setLine() 102 y0 = int(p0.fY * scale); in setLine() 110 if (y0 > y1) { in setLine() 113 swap(y0, y1); in setLine() 117 int top = SkFDot6Round(y0); in setLine() 125 SkFixed slope = SkFDot6Div(x1 - x0, y1 - y0); in setLine() 126 const SkFDot6 dy = SkEdge_Compute_DY(top, y0); in setLine()
|
/external/virglrenderer/src/gallium/auxiliary/util/ |
D | u_rect.h | 41 int y0, y1; member 52 a->y1 < b->y0 || in u_rect_test_intersection() 53 b->y1 < a->y0)); in u_rect_test_intersection() 66 if (b->y0 < a->y0) b->y0 = a->y0; in u_rect_find_intersection() 74 return (r->x1 - r->x0) * (r->y1 - r->y0); in u_rect_area() 85 b->x0 = b->x1 = b->y0 = b->y1 = 0; in u_rect_possible_intersection() 95 d->y0 = MIN2(a->y0, b->y0); in u_rect_union()
|
/external/libvpx/libvpx/vp8/encoder/x86/ |
D | quantize_sse4.c | 36 __m128i x0, x1, y0, y1, x_minus_zbin0, x_minus_zbin1, dqcoeff0, dqcoeff1; in vp8_regular_quantize_b_sse4_1() local 76 y0 = _mm_mulhi_epi16(x0, quant0); in vp8_regular_quantize_b_sse4_1() 79 y0 = _mm_add_epi16(y0, x0); in vp8_regular_quantize_b_sse4_1() 84 y0 = _mm_mulhi_epi16(y0, quant_shift0); in vp8_regular_quantize_b_sse4_1() 88 y0 = _mm_sign_epi16(y0, z0); in vp8_regular_quantize_b_sse4_1() 92 SELECT_EOB(1, 0, x_minus_zbin0, y0, qcoeff0); in vp8_regular_quantize_b_sse4_1() 93 SELECT_EOB(2, 1, x_minus_zbin0, y0, qcoeff0); in vp8_regular_quantize_b_sse4_1() 94 SELECT_EOB(3, 4, x_minus_zbin0, y0, qcoeff0); in vp8_regular_quantize_b_sse4_1() 96 SELECT_EOB(5, 5, x_minus_zbin0, y0, qcoeff0); in vp8_regular_quantize_b_sse4_1() 97 SELECT_EOB(6, 2, x_minus_zbin0, y0, qcoeff0); in vp8_regular_quantize_b_sse4_1() [all …]
|
D | vp8_quantize_sse2.c | 40 __m128i sz0, x0, sz1, x1, y0, y1, x_minus_zbin0, x_minus_zbin1; in vp8_regular_quantize_b_sse2() local 89 y0 = _mm_mulhi_epi16(x0, quant0); in vp8_regular_quantize_b_sse2() 92 y0 = _mm_add_epi16(y0, x0); in vp8_regular_quantize_b_sse2() 97 y0 = _mm_mulhi_epi16(y0, quant_shift0); in vp8_regular_quantize_b_sse2() 101 y0 = _mm_xor_si128(y0, sz0); in vp8_regular_quantize_b_sse2() 103 y0 = _mm_sub_epi16(y0, sz0); in vp8_regular_quantize_b_sse2() 106 _mm_store_si128((__m128i *)(y), y0); in vp8_regular_quantize_b_sse2() 129 y0 = _mm_load_si128((__m128i *)(d->qcoeff)); in vp8_regular_quantize_b_sse2() 133 y0 = _mm_mullo_epi16(y0, dequant0); in vp8_regular_quantize_b_sse2() 136 _mm_store_si128((__m128i *)(d->dqcoeff), y0); in vp8_regular_quantize_b_sse2() [all …]
|
/external/swiftshader/src/OpenGL/libGLESv2/ |
D | Device.cpp | 209 clearRect.clip(scissorRect.x0, scissorRect.y0, scissorRect.x1, scissorRect.y1); in clearColor() 229 clearRect.clip(scissorRect.x0, scissorRect.y0, scissorRect.x1, scissorRect.y1); in clearDepth() 232 depthBuffer->clearDepth(z, clearRect.x0, clearRect.y0, clearRect.width(), clearRect.height()); in clearDepth() 246 clearRect.clip(scissorRect.x0, scissorRect.y0, scissorRect.x1, scissorRect.y1); in clearStencil() 249 …stencilBuffer->clearStencil(stencil, mask, clearRect.x0, clearRect.y0, clearRect.width(), clearRec… in clearStencil() 468 flipY = (sourceRect->y0 < sourceRect->y1) ^ (destRect->y0 < destRect->y1); in stretchRect() 473 flipY = (sourceRect->y0 > sourceRect->y1); in stretchRect() 478 flipY = (destRect->y0 > destRect->y1); in stretchRect() 488 sRect.y0 = sourceRect->y0; in stretchRect() 497 if(sRect.y0 > sRect.y1) in stretchRect() [all …]
|
/external/swiftshader/src/OpenGL/libGLES_CM/ |
D | Device.cpp | 179 clearRect.clip(scissorRect.x0, scissorRect.y0, scissorRect.x1, scissorRect.y1); in clearColor() 197 clearRect.clip(scissorRect.x0, scissorRect.y0, scissorRect.x1, scissorRect.y1); in clearDepth() 200 depthBuffer->clearDepth(z, clearRect.x0, clearRect.y0, clearRect.width(), clearRect.height()); in clearDepth() 214 clearRect.clip(scissorRect.x0, scissorRect.y0, scissorRect.x1, scissorRect.y1); in clearStencil() 217 …stencilBuffer->clearStencil(stencil, mask, clearRect.x0, clearRect.y0, clearRect.width(), clearRec… in clearStencil() 340 sRect.y0 = 0; in stretchRect() 352 dRect.y0 = 0; in stretchRect() 358 …ing = (sRect.x1 - sRect.x0 != dRect.x1 - dRect.x0) || (sRect.y1 - sRect.y0 != dRect.y1 - dRect.y0); in stretchRect() 414 …unsigned char *sourceBytes = (unsigned char*)source->lockInternal(sRect.x0, sRect.y0, sRect.slice,… in stretchRect() 415 …unsigned char *destBytes = (unsigned char*)dest->lockInternal(dRect.x0, dRect.y0, dRect.slice, LOC… in stretchRect() [all …]
|
/external/mesa3d/src/util/format/ |
D | u_format_yuv.c | 496 uint8_t y0, y1, u, v; in util_format_uyvy_unpack_rgba_float() local 502 y0 = (value >> 8) & 0xff; in util_format_uyvy_unpack_rgba_float() 506 util_format_yuv_to_rgb_float(y0, u, v, &dst[0], &dst[1], &dst[2]); in util_format_uyvy_unpack_rgba_float() 519 y0 = (value >> 8) & 0xff; in util_format_uyvy_unpack_rgba_float() 523 util_format_yuv_to_rgb_float(y0, u, v, &dst[0], &dst[1], &dst[2]); in util_format_uyvy_unpack_rgba_float() 544 uint8_t y0, y1, u, v; in util_format_uyvy_unpack_rgba_8unorm() local 550 y0 = (value >> 8) & 0xff; in util_format_uyvy_unpack_rgba_8unorm() 554 util_format_yuv_to_rgb_8unorm(y0, u, v, &dst[0], &dst[1], &dst[2]); in util_format_uyvy_unpack_rgba_8unorm() 567 y0 = (value >> 8) & 0xff; in util_format_uyvy_unpack_rgba_8unorm() 571 util_format_yuv_to_rgb_8unorm(y0, u, v, &dst[0], &dst[1], &dst[2]); in util_format_uyvy_unpack_rgba_8unorm() [all …]
|
/external/mesa3d/src/mesa/program/ |
D | prog_noise.c | 257 float y0 = y - Y0; in _mesa_noise2() local 266 if (x0 > y0) { in _mesa_noise2() 280 y1 = y0 - j1 + G2; in _mesa_noise2() 282 y2 = y0 - 1.0f + 2.0f * G2; in _mesa_noise2() 289 t0 = 0.5f - x0 * x0 - y0 * y0; in _mesa_noise2() 294 n0 = t0 * t0 * grad2(perm[ii + perm[jj]], x0, y0); in _mesa_noise2() 343 float y0 = y - Y0; in _mesa_noise3() local 356 if (x0 >= y0) { in _mesa_noise3() 357 if (y0 >= z0) { in _mesa_noise3() 383 if (y0 < z0) { in _mesa_noise3() [all …]
|
/external/dng_sdk/source/ |
D | dng_1d_table.cpp | 88 real64 y0 = fTable [lower]; in SubDivide() local 91 real64 delta = (y1 - y0) / (real64) range; in SubDivide() 96 y0 += delta; in SubDivide() 98 fTable [j] = (real32) y0; in SubDivide() 161 real64 y0 = fTable [0]; in Expand16() local 164 real64 base = y0 * 65535.0 + 0.5; in Expand16() 165 real64 slope = (y1 - y0) * 65535.0; in Expand16() 183 y0 = y1; in Expand16() 186 base = y0 * 65535.0 + 0.5; in Expand16() 187 slope = (y1 - y0) * 65535.0; in Expand16()
|
/external/apache-commons-math/src/main/java/org/apache/commons/math/ode/nonstiff/ |
D | RungeKuttaIntegrator.java | 96 final double t0, final double[] y0, in integrate() argument 100 sanityChecks(equations, t0, y0, t, y); in integrate() 107 if (y != y0) { in integrate() 108 System.arraycopy(y0, 0, y, 0, y0.length); in integrate() 112 yDotK [i] = new double[y0.length]; in integrate() 114 final double[] yTmp = new double[y0.length]; in integrate() 115 final double[] yDotTmp = new double[y0.length]; in integrate() 148 for (int j = 0; j < y0.length; ++j) { in integrate() 161 for (int j = 0; j < y0.length; ++j) { in integrate() 171 System.arraycopy(yTmp, 0, y, 0, y0.length); in integrate() [all …]
|
D | EmbeddedRungeKuttaIntegrator.java | 193 final double t0, final double[] y0, in integrate() argument 197 sanityChecks(equations, t0, y0, t, y); in integrate() 204 if (y != y0) { in integrate() 205 System.arraycopy(y0, 0, y, 0, y0.length); in integrate() 207 final double[][] yDotK = new double[stages][y0.length]; in integrate() 208 final double[] yTmp = new double[y0.length]; in integrate() 209 final double[] yDotTmp = new double[y0.length]; in integrate() 267 for (int j = 0; j < y0.length; ++j) { in integrate() 280 for (int j = 0; j < y0.length; ++j) { in integrate() 302 System.arraycopy(yTmp, 0, y, 0, y0.length); in integrate() [all …]
|
D | GraggBulirschStoerIntegrator.java | 459 private boolean tryStep(final double t0, final double[] y0, final double step, final int k, in tryStep() argument 471 for (int i = 0; i < y0.length; ++i) { in tryStep() 472 yTmp[i] = y0[i]; in tryStep() 473 yEnd[i] = y0[i] + subStep * f[0][i]; in tryStep() 482 System.arraycopy(yEnd, 0, yMiddle, 0, y0.length); in tryStep() 486 for (int i = 0; i < y0.length; ++i) { in tryStep() 514 for (int i = 0; i < y0.length; ++i) { in tryStep() 551 final double t0, final double[] y0, final double t, final double[] y) in integrate() argument 554 sanityChecks(equations, t0, y0, t, y); in integrate() 560 final double[] yDot0 = new double[y0.length]; in integrate() [all …]
|
/external/tensorflow/tensorflow/go/op/ |
D | gradients_test.go | 31 y0 = Square(s.SubScope("y0"), x1) 32 y1 = Square(s.SubScope("y1"), y0) 33 y2 = AddN(s.SubScope("y2"), []tf.Output{y0, x2}) 98 y0 = Square(s.SubScope("y0"), x) 99 y1 = Square(s.SubScope("y1"), y0) 102 grad := Gradients(s, []tf.Output{y0, y1}, []tf.Output{x}) 139 y0 = Square(s.SubScope("y0"), x) 140 y1 = Square(s.SubScope("y1"), y0) 143 grads0 := Gradients(s, []tf.Output{y1}, []tf.Output{y0}) 155 grads1 := Gradients(sub, []tf.Output{y0}, []tf.Output{x}, grads0[0]) [all …]
|
/external/apache-commons-math/src/main/java/org/apache/commons/math/analysis/solvers/ |
D | SecantSolver.java | 172 double y0 = f.value(x0); in solve() local 176 if (y0 * y1 >= 0) { in solve() 178 LocalizedFormats.SAME_SIGN_AT_ENDPOINTS, min, max, y0, y1); in solve() 182 double y2 = y0; in solve() 190 y0 = y1; in solve() 192 y2 = y0; in solve() 204 if (FastMath.abs(y1) > FastMath.abs(y0)) { in solve() 208 delta = (x0 - x1) / (1 - y0 / y1); in solve() 216 y0 = y1; in solve() 222 y2 = y0; in solve()
|
/external/pdfium/third_party/libopenjpeg20/ |
D | sparse_array.c | 97 OPJ_UINT32 y0, in opj_sparse_array_is_region_valid() argument 102 y0 >= sa->height || y1 <= y0 || y1 > sa->height); in opj_sparse_array_is_region_valid() 108 OPJ_UINT32 y0, in opj_sparse_array_int32_read_or_write() argument 121 if (!opj_sparse_array_is_region_valid(sa, x0, y0, x1, y1)) { in opj_sparse_array_int32_read_or_write() 125 block_y = y0 / sa->block_height; in opj_sparse_array_int32_read_or_write() 126 for (y = y0; y < y1; block_y ++, y += y_incr) { in opj_sparse_array_int32_read_or_write() 130 y_incr = (y == y0) ? sa->block_height - (y0 % sa->block_height) : in opj_sparse_array_int32_read_or_write() 146 OPJ_INT32* dest_ptr = buf + (y - y0) * (OPJ_SIZE_T)buf_line_stride + in opj_sparse_array_int32_read_or_write() 153 OPJ_INT32* dest_ptr = buf + (y - y0) * (OPJ_SIZE_T)buf_line_stride + in opj_sparse_array_int32_read_or_write() 167 … OPJ_INT32* OPJ_RESTRICT dest_ptr = buf + (y - y0) * (OPJ_SIZE_T)buf_line_stride in opj_sparse_array_int32_read_or_write() [all …]
|
/external/rust/crates/plotters/src/drawing/ |
D | area.rs | 22 y0: i32, field 34 let (mut x0, mut y0) = (self.x0, self.y0); in split() 42 let ret = Rect { x0, y0, x1, y1 }; in split() 45 y0 = y1 in split() 64 y0: compute_evenly_split(self.y0, self.y1, row, ri), in split_evenly() 65 y1: compute_evenly_split(self.y0, self.y1, row, ri + 1), in split_evenly() 77 let mut ys = vec![self.y0, self.y1]; in split_grid() 79 ys.extend(y_breaks.map(|v| v + self.y0)); in split_grid() 97 .map(move |(y0, y1)| { in split_grid() 101 .map(move |(x0, x1)| Self { x0, y0, x1, y1 }) in split_grid() [all …]
|
/external/mesa3d/src/intel/isl/ |
D | isl_tiled_memcpy.c | 232 uint32_t y0, uint32_t y1, 251 uint32_t y0, uint32_t y1, in linear_to_xtiled() argument 263 src += (ptrdiff_t)y0 * src_pitch; in linear_to_xtiled() 265 for (yo = y0 * xtile_width; yo < y1 * xtile_width; yo += xtile_width) { in linear_to_xtiled() 293 uint32_t y0, uint32_t y3, in linear_to_ytiled() argument 312 uint32_t y1 = MIN2(y3, ALIGN_UP(y0, 4)); in linear_to_ytiled() 328 src += (ptrdiff_t)y0 * src_pitch; in linear_to_ytiled() 330 if (y0 != y1) { in linear_to_ytiled() 331 for (yo = y0 * column_width; yo < y1 * column_width; yo += column_width) { in linear_to_ytiled() 415 uint32_t y0, uint32_t y1, in xtiled_to_linear() argument [all …]
|
/external/mesa3d/src/gallium/drivers/llvmpipe/ |
D | lp_setup_point.c | 123 float y0 = info->v0[0][1] - setup->pixel_offset; in texcoord_coef() local 127 info->a0[slot][0] = 0.5 - (dadx * x0 + dady * y0); in texcoord_coef() 139 float y0 = info->v0[0][1] - setup->pixel_offset; in texcoord_coef() local 147 info->a0[slot][1] = 0.5 - (dadx * x0 + dady * y0); in texcoord_coef() 382 int x0, y0; in try_setup_point() local 389 y0 = subpixel_snap(v0[0][1] - pixel_offset) - fixed_width/2; in try_setup_point() 393 bbox.y0 = (y0 + (FIXED_ONE-1) + adj) >> FIXED_ORDER; in try_setup_point() 394 bbox.y1 = (y0 + fixed_width + (FIXED_ONE-1) + adj) >> FIXED_ORDER; in try_setup_point() 411 const int y0 = subpixel_snap(v0[0][1]) - adj; in try_setup_point() local 425 bbox.y0 = y0 >> FIXED_ORDER; in try_setup_point() [all …]
|