/third_party/mesa3d/src/gallium/drivers/llvmpipe/ |
H A D | lp_setup_point.c | 53 float (*dadx)[4]; member 71 info->dadx[slot][i] = 0.0f; in constant_coef() 94 info->dadx[slot][i] = 0.0f; in point_persp_coeff() 120 float dadx = FIXED_ONE / (float)info->dx12; in texcoord_coef() local 125 info->dadx[slot][0] = dadx; in texcoord_coef() 127 info->a0[slot][0] = 0.5 - (dadx * x0 + dady * y0); in texcoord_coef() 130 info->dadx[slot][0] *= w0; in texcoord_coef() 136 float dadx = 0.0f; in texcoord_coef() local 145 info->dadx[slo in texcoord_coef() [all...] |
H A D | lp_linear_interp.c | 74 const __m128i dadx = interp->dadx; in interp_0_8() local 79 a0 = _mm_add_epi16(a0, dadx); // a0 += dadx in interp_0_8() 82 a0 = _mm_add_epi16(a0, dadx); // a0 += dadx in interp_0_8() 126 const float *dadx, in lp_linear_init_interp() 148 dsdx[j] = dadx[j] * oow; in lp_linear_init_interp() 156 dsdx[j] = dadx[j]; in lp_linear_init_interp() 205 interp->dadx in lp_linear_init_interp() 120 lp_linear_init_interp(struct lp_linear_interp *interp, int x, int y, int width, int height, unsigned usage_mask, boolean perspective, float oow, const float *a0, const float *dadx, const float *dady) lp_linear_init_interp() argument 229 lp_linear_init_interp(struct lp_linear_interp *interp, int x, int y, int width, int height, unsigned usage_mask, boolean perspective, float oow, const float *a0, const float *dadx, const float *dady) lp_linear_init_interp() argument [all...] |
H A D | lp_state_fs_linear.c | 69 __m128i dadx; member 358 const float (*dadx)[4], in blit_rgba_blit() 374 dadx[0][3] != 0.0 || in blit_rgba_blit() 410 const float (*dadx)[4], in blit_rgb1_blit() 426 dadx[0][3] != 0.0 || in blit_rgb1_blit() 470 const float (*dadx)[4], in blit_rgba() 484 a0[1][0], dadx[1][0], dady[1][0], in blit_rgba() 485 a0[1][1], dadx[1][1], dady[1][1], in blit_rgba() 486 a0[0][3], dadx[0][3], dady[0][3])) in blit_rgba() 509 const float (*dadx)[ in blit_rgb1() 354 blit_rgba_blit(const struct lp_rast_state *state, unsigned x, unsigned y, unsigned width, unsigned height, const float (*a0)[4], const float (*dadx)[4], const float (*dady)[4], uint8_t *color, unsigned stride) blit_rgba_blit() argument 406 blit_rgb1_blit(const struct lp_rast_state *state, unsigned x, unsigned y, unsigned width, unsigned height, const float (*a0)[4], const float (*dadx)[4], const float (*dady)[4], uint8_t *color, unsigned stride) blit_rgb1_blit() argument 466 blit_rgba(const struct lp_rast_state *state, unsigned x, unsigned y, unsigned width, unsigned height, const float (*a0)[4], const float (*dadx)[4], const float (*dady)[4], uint8_t *color, unsigned stride) blit_rgba() argument 505 blit_rgb1(const struct lp_rast_state *state, unsigned x, unsigned y, unsigned width, unsigned height, const float (*a0)[4], const float (*dadx)[4], const float (*dady)[4], uint8_t *color, unsigned stride) blit_rgb1() argument 549 blit_rgba_blend_premul(const struct lp_rast_state *state, unsigned x, unsigned y, unsigned width, unsigned height, const float (*a0)[4], const float (*dadx)[4], const float (*dady)[4], uint8_t *color, unsigned stride) blit_rgba_blend_premul() argument 588 linear_red(const struct lp_rast_state *state, unsigned x, unsigned y, unsigned width, unsigned height, const float (*a0)[4], const float (*dadx)[4], const float (*dady)[4], uint8_t *color, unsigned stride) linear_red() argument 618 linear_no_op(const struct lp_rast_state *state, unsigned x, unsigned y, unsigned width, unsigned height, const float (*a0)[4], const float (*dadx)[4], const float (*dady)[4], uint8_t *color, unsigned stride) linear_no_op() argument [all...] |
H A D | lp_linear_fastpath.c | 64 const float (*dadx)[4], in lp_linear_blit_rgba_blit() 77 dadx[0][3] != 0.0 || in lp_linear_blit_rgba_blit() 113 const float (*dadx)[4], in lp_linear_blit_rgb1_blit() 126 dadx[0][3] != 0.0 || in lp_linear_blit_rgb1_blit() 169 const float (*dadx)[4], in lp_linear_purple() 60 lp_linear_blit_rgba_blit(const struct lp_rast_state *state, unsigned x, unsigned y, unsigned width, unsigned height, const float (*a0)[4], const float (*dadx)[4], const float (*dady)[4], uint8_t *color, unsigned stride) lp_linear_blit_rgba_blit() argument 109 lp_linear_blit_rgb1_blit(const struct lp_rast_state *state, unsigned x, unsigned y, unsigned width, unsigned height, const float (*a0)[4], const float (*dadx)[4], const float (*dady)[4], uint8_t *color, unsigned stride) lp_linear_blit_rgb1_blit() argument 165 lp_linear_purple(const struct lp_rast_state *state, unsigned x, unsigned y, unsigned width, unsigned height, const float (*a0)[4], const float (*dadx)[4], const float (*dady)[4], uint8_t *color, unsigned stride) lp_linear_purple() argument
|
H A D | lp_setup_line.c | 55 float (*dadx)[4]; member 70 info->dadx[slot][i] = 0.0f; in constant_coef() 76 * Compute a0, dadx and dady for a linearly interpolated coefficient, 89 float dadx = da21 * info->dx * info->oneoverarea; in linear_coef() local 92 info->dadx[slot][i] = dadx; in linear_coef() 96 (dadx * (info->v1[0][0] - setup->pixel_offset) + in linear_coef() 102 * Compute a0, dadx and dady for a perspective-corrected interpolant, 105 * the plane coefficients (a0, dadx, dady). 121 float dadx in perspective_coef() local [all...] |
H A D | lp_state_setup.c | 71 LLVMValueRef dadx; member 92 LLVMValueRef dadx, in store_coef() 103 dadx, in store_coef() 104 LLVMBuildGEP(builder, args->dadx, &idx, 1, "")); in store_coef() 387 /* Calculate dadx (vec4f) in calc_coef4() 391 LLVMValueRef dadx = LLVMBuildFSub(b, da01_dy20_ooa, da20_dy01_ooa, "dadx"); in calc_coef4() local 401 LLVMValueRef dadx_x0 = LLVMBuildFMul(b, dadx, x0_center, "dadx_x0"); in calc_coef4() 407 out[1] = dadx; in calc_coef4() 438 * Compute a0, dadx an 88 store_coef(struct gallivm_state *gallivm, const struct lp_setup_args *args, unsigned slot, LLVMValueRef a0, LLVMValueRef dadx, LLVMValueRef dady) store_coef() argument 916 float dadx = sdadx[0][i]; lp_dump_setup_coef() local 928 float dadx = sdadx[1 + slot][i]; lp_dump_setup_coef() local [all...] |
H A D | lp_linear_priv.h | 57 __m128i dadx; member 136 const float *dadx, 146 const float (*dadx)[4],
|
H A D | lp_bld_interp.c | 99 * a = a0 + dadx*x + dady*y 107 * da'dx = (dadx - dwdx*a)*oow 324 LLVMValueRef dadx = coeff_bld->zero; in attribs_update_simple() local 336 dadx = coeff_bld->one; in attribs_update_simple() 357 dadx = lp_build_extract_broadcast(gallivm, setup_bld->type, in attribs_update_simple() 388 * a = a0 + (x * dadx + y * dady) in attribs_update_simple() 390 a = lp_build_fmuladd(builder, dadx, chan_pixoffx, a); in attribs_update_simple() 447 LLVMValueRef dadx = coeff_bld->zero; in lp_build_interp_soa_indirect() local 467 dadx = lp_build_gather(gallivm, coeff_bld->type.length, in lp_build_interp_soa_indirect() 480 * a = a0 + (x * dadx in lp_build_interp_soa_indirect() 600 LLVMValueRef dadx = coeff_bld->zero; lp_build_interp_soa() local [all...] |
H A D | lp_state_fs_fastpath.c | 51 const void *dadx, in no_op() 149 const void *dadx, in red() 176 const void *dadx, in green() 46 no_op(const struct lp_jit_context *context, uint32_t x, uint32_t y, uint32_t facing, const void *a0, const void *dadx, const void *dady, uint8_t **cbufs, uint8_t *depth, uint64_t mask, struct lp_jit_thread_data *thread_data, unsigned *strides, unsigned depth_stride, unsigned *color_sample_stride, unsigned depth_sample_stride) no_op() argument 144 red(const struct lp_jit_context *context, uint32_t x, uint32_t y, uint32_t facing, const void *a0, const void *dadx, const void *dady, uint8_t **cbufs, uint8_t *depth, uint64_t int_mask, struct lp_jit_thread_data *thread_data, unsigned *strides, unsigned depth_stride, unsigned *sample_stride, unsigned depth_sample_stride) red() argument 171 green(const struct lp_jit_context *context, uint32_t x, uint32_t y, uint32_t facing, const void *a0, const void *dadx, const void *dady, uint8_t **cbufs, uint8_t *depth, uint64_t int_mask, struct lp_jit_thread_data *thread_data, unsigned *strides, unsigned depth_stride, unsigned *sample_stride, unsigned depth_sample_stride) green() argument
|
H A D | lp_linear.c | 81 const float (*dadx)[4], in lp_fs_linear_run() 94 if (dadx[0][3] != 0.0f || in lp_fs_linear_run() 152 dadx[i+1], in lp_fs_linear_run() 185 x, y, width, height, a0, dadx, dady)) { in lp_fs_linear_run() 77 lp_fs_linear_run(const struct lp_rast_state *state, unsigned x, unsigned y, unsigned width, unsigned height, const float (*a0)[4], const float (*dadx)[4], const float (*dady)[4], uint8_t *color, unsigned stride) lp_fs_linear_run() argument
|
H A D | lp_state_setup.h | 45 float (*dadx)[4], 53 * attribute interpolants (a0, dadx, dady) from three of those
|
H A D | lp_jit.h | 304 * @param dadx shader input dadx 319 const void *dadx, 413 const float (*dadx)[4],
|
H A D | lp_linear_sampler.c | 723 const float (*dadx)[4], in lp_linear_init_sampler() 736 float dsdx = dadx[schan->u.index+foo][schan->swizzle]; in lp_linear_init_sampler() 740 float dtdx = dadx[tchan->u.index+foo][tchan->swizzle]; in lp_linear_init_sampler() 717 lp_linear_init_sampler(struct lp_linear_sampler *samp, const struct lp_tgsi_texture_info *info, const struct lp_sampler_static_state *sampler_state, const struct lp_jit_texture *texture, int x0, int y0, int width, int height, const float (*a0)[4], const float (*dadx)[4], const float (*dady)[4]) lp_linear_init_sampler() argument
|
/third_party/mesa3d/src/gallium/drivers/softpipe/ |
H A D | sp_fs_exec.c | 96 const float dadx = coef->dadx[chan]; in setup_pos_vector() local 98 const float a0 = coef->a0[chan] + dadx * x + dady * y; in setup_pos_vector() 100 quadpos->xyzw[chan].f[1] = a0 + dadx; in setup_pos_vector() 102 quadpos->xyzw[chan].f[3] = a0 + dadx + dady; in setup_pos_vector()
|
H A D | sp_setup.c | 412 coef->dadx[i] = 0; in const_coeff() 422 * Compute a0, dadx and dady for a linearly interpolated coefficient, 436 float dadx = a * setup->oneoverarea; in tri_linear_coeff() local 441 coef->dadx[i] = dadx; in tri_linear_coeff() 449 * triangles with very large values of dadx or dady as it will in tri_linear_coeff() 457 (dadx * (setup->vmin[0][0] - setup->pixel_offset) + in tri_linear_coeff() 463 * Compute a0, dadx and dady for a perspective-corrected interpolant, 466 * the plane coefficients (a0, dadx, dady). 486 float dadx in tri_persp_coeff() local 841 const float dadx = da * setup->emaj.dx * setup->oneoverarea; line_linear_coeff() local 865 const float dadx = da * setup->emaj.dx * setup->oneoverarea; line_persp_coeff() local [all...] |
H A D | sp_quad_depth_test_tmp.h | 58 const float dzdx = quads[0]->posCoef->dadx[2]; in NAME()
|
H A D | sp_quad_depth_test.c | 138 const float dzdx = quad->posCoef->dadx[2]; in interpolate_quad_depth()
|
/third_party/mesa3d/src/gallium/auxiliary/tgsi/ |
H A D | tgsi_exec.h | 96 float dadx[TGSI_NUM_CHANNELS]; member
|
H A D | tgsi_exec.c | 2694 const float dadx = mach->InterpCoefs[attrib].dadx[chan]; in interp_linear_offset() local 2696 const float delta = ofs_x * dadx + ofs_y * dady; in interp_linear_offset() 2710 const float dadx = mach->InterpCoefs[attrib].dadx[chan]; in eval_linear_coef() local 2712 const float a0 = mach->InterpCoefs[attrib].a0[chan] + dadx * x + dady * y; in eval_linear_coef() 2715 mach->Inputs[attrib].xyzw[chan].f[1] = a0 + dadx; in eval_linear_coef() 2717 mach->Inputs[attrib].xyzw[chan].f[3] = a0 + dadx + dady; in eval_linear_coef() 2734 const float dadx = mach->InterpCoefs[attrib].dadx[cha in interp_perspective_offset() local 2752 const float dadx = mach->InterpCoefs[attrib].dadx[chan]; eval_perspective_coef() local [all...] |