Home
last modified time | relevance | path

Searched +refs:wz +refs:z (Results 1 – 25 of 1561) sorted by relevance

12345678910>>...63

/dports/science/fasthenry/fasthenry-3.0wr/src/fasthenry/
H A Dwritefastcap.c88 z = node0->z - 0.5 * wz * width + 0.5 * hz * height;
93 z = node0->z - 0.5 * wz * width - 0.5 * hz * height;
98 z = node0->z + 0.5 * wz * width - 0.5 * hz * height;
103 z = node0->z + 0.5 * wz * width + 0.5 * hz * height;
114 z = node1->z - 0.5 * wz * width + 0.5 * hz * height;
119 z = node1->z - 0.5 * wz * width - 0.5 * hz * height;
124 z = node1->z + 0.5 * wz * width - 0.5 * hz * height;
286 z = gp->z[j] - 0.5 * wz * width;
291 z = gp->z[j] + 0.5 * wz * width;
296 z = gp->z[k] + 0.5 * wz * width;
[all …]
/dports/graphics/mirtk/MIRTK-2.0.0-122-g38210fa/Modules/Transformation/src/
H A DFluidFreeFormTransformation.cc280 memcpy(wz, z, no * sizeof(double)); in Approximate()
294 dz[idx] -= (wz[idx] - z[idx]); in Approximate()
345 memcpy(wz, z, no * sizeof(double)); in Approximate()
359 dz[idx] -= (wz[idx] - z[idx]); in Approximate()
404 memcpy(wz, z, no * sizeof(double)); in Approximate()
418 dz[idx] -= (wz[idx] - z[idx]); in Approximate()
521 memcpy(wz, z, no * sizeof(double)); in ApproximateAsNew()
570 memcpy(wz, z, no * sizeof(double)); in ApproximateAsNew()
605 memcpy(wz, z, no * sizeof(double)); in ApproximateDOFs()
627 rz[idx] = dz[idx] - (wz[idx] - z[idx]); in ApproximateDOFs()
[all …]
H A DMultiLevelFreeFormTransformation.cc149 memcpy(wz, z, no * sizeof(double)); in Approximate()
162 dz[idx] -= (wz[idx] - z[idx]); in Approximate()
168 Deallocate(wz); in Approximate()
207 memcpy(wz, z, no * sizeof(double)); in Approximate()
220 dz[idx] -= (wz[idx] - z[idx]); in Approximate()
226 Deallocate(wz); in Approximate()
261 memcpy(wz, z, no * sizeof(double)); in Approximate()
274 dz[idx] -= (wz[idx] - z[idx]); in Approximate()
280 Deallocate(wz); in Approximate()
410 memcpy(wz, z, no * sizeof(double)); in ApproximateDOFs()
[all …]
H A DHomogeneousTransformation.cc146 double *wz = Allocate<double>(no); in Approximate() local
169 memcpy(wz, z, no * sizeof(double)); in Approximate()
170 this->Transform(no, wx, wy, wz, t); in Approximate()
196 Deallocate(wz); in Approximate()
223 double *wz = Allocate<double>(no); in Approximate() local
242 memcpy(wz, z, no * sizeof(double)); in Approximate()
265 Deallocate(wz); in Approximate()
285 double *wz = Allocate<double>(no); in Approximate() local
304 memcpy(wz, z, no * sizeof(double)); in Approximate()
305 this->Transform(no, wx, wy, wz, t); in Approximate()
[all …]
/dports/graphics/mirtk/MIRTK-2.0.0-122-g38210fa/Modules/Image/include/mirtk/
H A DFastLinearImageGradientFunction.hxx258 const int k = ComputeWeights(z, wz); in Get3D()
282 nrm += wx[a] * wy[b] * wz[c]; in Get3D()
305 const int k = ComputeWeights(z, wz); in GetWithPadding3D()
346 const int k = ComputeWeights(z, wz); in Get3D()
360 val._x += wd[a] * wy[b] * wz[c] * coeff; in Get3D()
361 val._y += wx[a] * wd[b] * wz[c] * coeff; in Get3D()
379 const int k = ComputeWeights(z, wz); in GetWithPadding3D()
420 const int k = ComputeWeights(z, wz); in Get4D()
468 const int k = ComputeWeights(z, wz); in GetWithPadding4D()
508 const int k = ComputeWeights(z, wz); in Get4D()
[all …]
H A DLinearInterpolateImageFunction.hxx279 const int k = ComputeWeights(z, wz); in Get3D()
324 const int k = ComputeWeights(z, wz); in GetWithPadding3D()
398 const int k = ComputeWeights(z, wz); in GetWithPadding3D()
435 const int k = ComputeWeights(z, wz); in Get4D()
481 const int k = ComputeWeights(z, wz); in GetWithPadding4D()
566 const int k = ComputeWeights(z, wz); in GetWithPadding4D()
683 const int k = ComputeWeights(z, wz); in GetInside3D()
712 const int k = ComputeWeights(z, wz); in GetInside4D()
930 const int k = ComputeWeights(z, wz); in Jacobian3D()
1016 const int k = ComputeWeights(z, wz); in Jacobian4D()
[all …]
H A DBSplineInterpolateImageFunction.hxx312 ComputeBSplineIndicesAndWeights(x, y, z, _SplineDegree, i, j, k, wx, wy, wz); in Get3D()
322 wyz = wy[b] * wz[c]; in Get3D()
349 ComputeBSplineIndicesAndWeights(x, y, z, _SplineDegree, i, j, k, wx, wy, wz); in GetWithPadding3D()
361 wyz = wy[b] * wz[c]; in GetWithPadding3D()
396 ComputeBSplineIndicesAndWeights(x, y, z, _SplineDegree, i, j, k, wx, wy, wz); in Get3D()
404 wyz = wy[b] * wz[c]; in Get3D()
428 ComputeBSplineIndicesAndWeights(x, y, z, _SplineDegree, i, j, k, wx, wy, wz); in GetWithPadding3D()
465 ComputeBSplineIndicesAndWeights(x, y, z, t, _SplineDegree, i, j, k, l, wx, wy, wz, wt); in Get4D()
500 ComputeBSplineIndicesAndWeights(x, y, z, t, _SplineDegree, i, j, k, l, wx, wy, wz, wt); in GetWithPadding4D()
550 ComputeBSplineIndicesAndWeights(x, y, z, t, _SplineDegree, i, j, k, l, wx, wy, wz, wt); in Get4D()
[all …]
H A DCubicBSplineInterpolateImageFunction.hxx324 Real wz[4]; Kernel::Weights(Real(z - k), wz); in Get3D() local
338 wyz = wy[b] * wz[c]; in Get3D()
367 Real wz[4]; Kernel::Weights(Real(z - k), wz); in GetWithPadding3D() local
415 Real wz[4]; Kernel::Weights(Real(z - k), wz); in Get3D() local
455 Real wz[4]; Kernel::Weights(Real(z - k), wz); in GetWithPadding3D() local
500 Real wz[4]; Kernel::Weights(Real(z - k), wz); in Get4D() local
545 Real wz[4]; Kernel::Weights(Real(z - k), wz); in GetWithPadding4D() local
598 Real wz[4]; Kernel::Weights(Real(z - k), wz); in Get4D() local
640 Real wz[4]; Kernel::Weights(Real(z - k), wz); in GetWithPadding4D() local
772 Real wz[4]; Kernel::Weights(Real(z - k), wz); in GetInside3D() local
[all …]
/dports/math/R-cran-VGAM/VGAM/R/
H A Dfamily.functions.R150 n <- nrow(wz)
152 dimm.value <- if (is.matrix(wz)) ncol(wz) else 1
197 ResSS.vgam <- function(z, wz, M) { argument
201 return(sum(c(wz) * c(z^2)))
203 wz.z <- mux22(t(wz), z, M = M, as.matrix = TRUE)
204 sum(wz.z * z)
259 if (z$error.code)
263 z$values <- z$values[ord, , drop = FALSE]
265 z$vectors <- z$vectors[, ord, , drop = FALSE]
294 wz <- as.matrix(wz)
[all …]
/dports/devel/fuzzylite/fuzzylite-6.0/fuzzylite/src/defuzzifier/
H A DWeightedSumCustom.cpp73 scalar w, z, wz; in defuzzify() local
77 z = activated.getTerm()->membership(w); in defuzzify()
79 wz = implication ? implication->compute(w, z) : (w * z); in defuzzify()
81 sum = aggregation->compute(sum, wz); in defuzzify()
83 sum += wz; in defuzzify()
87 scalar w, z, wz; in defuzzify() local
91 z = activated.getTerm()->tsukamoto(w, minimum, maximum); in defuzzify()
93 wz = implication ? implication->compute(w, z) : (w * z); in defuzzify()
95 sum = aggregation->compute(sum, wz); in defuzzify()
97 sum += wz; in defuzzify()
H A DWeightedAverageCustom.cpp74 scalar w, z, wz; in defuzzify() local
78 z = activated.getTerm()->membership(w); in defuzzify()
80 wz = implication ? implication->compute(w, z) : (w * z); in defuzzify()
82 sum = aggregation->compute(sum, wz); in defuzzify()
85 sum += wz; in defuzzify()
90 scalar w, z, wz; in defuzzify() local
94 z = activated.getTerm()->tsukamoto(w, minimum, maximum); in defuzzify()
96 wz = implication ? implication->compute(w, z) : (w * z); in defuzzify()
98 sum = aggregation->compute(sum, wz); in defuzzify()
101 sum += wz; in defuzzify()
/dports/math/cglm/cglm-0.8.4/include/cglm/
H A Dquat.h477 zz = s * z * z; xz = s * x * z; wz = s * w * z; in glm_quat_mat4()
483 dest[0][1] = xy + wz; in glm_quat_mat4()
487 dest[1][0] = xy - wz; in glm_quat_mat4()
524 zz = s * z * z; xz = s * x * z; wz = s * w * z; in glm_quat_mat4t()
530 dest[1][0] = xy + wz; in glm_quat_mat4t()
534 dest[0][1] = xy - wz; in glm_quat_mat4t()
571 zz = s * z * z; xz = s * x * z; wz = s * w * z; in glm_quat_mat3()
577 dest[0][1] = xy + wz; in glm_quat_mat3()
581 dest[1][0] = xy - wz; in glm_quat_mat3()
610 zz = s * z * z; xz = s * x * z; wz = s * w * z; in glm_quat_mat3t()
[all …]
/dports/graphics/clutter/clutter-1.26.4/clutter/
H A Dclutter-util.c183 return matrix->xw * matrix->yz * matrix->zy * matrix->wz in _clutter_util_matrix_determinant()
184 - matrix->xz * matrix->yw * matrix->zy * matrix->wz in _clutter_util_matrix_determinant()
185 - matrix->xw * matrix->yy * matrix->zz * matrix->wz in _clutter_util_matrix_determinant()
186 + matrix->xy * matrix->yw * matrix->zz * matrix->wz in _clutter_util_matrix_determinant()
187 + matrix->xz * matrix->yy * matrix->zw * matrix->wz in _clutter_util_matrix_determinant()
188 - matrix->xy * matrix->yz * matrix->zw * matrix->wz in _clutter_util_matrix_determinant()
195 + matrix->xw * matrix->yy * matrix->zx * matrix->wz in _clutter_util_matrix_determinant()
229 res->w = matrix->wz * point->x in _clutter_util_matrix_transpose_vector4_transform()
231 + matrix->wz * point->z in _clutter_util_matrix_transpose_vector4_transform()
310 res->z = (ascl * a->z) + (bscl * b->z); in _clutter_util_vertex_combine()
[all …]
/dports/x11-wm/muffin/muffin-4.8.0/clutter/clutter/
H A Dclutter-util.c200 return matrix->xw * matrix->yz * matrix->zy * matrix->wz in _clutter_util_matrix_determinant()
201 - matrix->xz * matrix->yw * matrix->zy * matrix->wz in _clutter_util_matrix_determinant()
202 - matrix->xw * matrix->yy * matrix->zz * matrix->wz in _clutter_util_matrix_determinant()
203 + matrix->xy * matrix->yw * matrix->zz * matrix->wz in _clutter_util_matrix_determinant()
204 + matrix->xz * matrix->yy * matrix->zw * matrix->wz in _clutter_util_matrix_determinant()
205 - matrix->xy * matrix->yz * matrix->zw * matrix->wz in _clutter_util_matrix_determinant()
212 + matrix->xw * matrix->yy * matrix->zx * matrix->wz in _clutter_util_matrix_determinant()
246 res->w = matrix->wz * point->x in _clutter_util_matrix_transpose_vector4_transform()
248 + matrix->wz * point->z in _clutter_util_matrix_transpose_vector4_transform()
327 res->z = (ascl * a->z) + (bscl * b->z); in _clutter_util_vertex_combine()
[all …]
/dports/math/vtk6/VTK-6.2.0/Rendering/Volume/
H A DvtkVolumeTextureMapper3D.cxx85 double wx, wy, wz; in vtkAbstractObjectFactoryNewMacro() local
87 int x, y, z; in vtkAbstractObjectFactoryNewMacro() local
202 z = vtkMath::Floor( fz ); in vtkAbstractObjectFactoryNewMacro()
203 wz = fz - z; in vtkAbstractObjectFactoryNewMacro()
218 dataPtr + components * ( z*inputDimensions[0]*inputDimensions[1] + in vtkAbstractObjectFactoryNewMacro()
404 int x, y, z; in vtkVolumeTextureMapper3DComputeGradients() local
496 double wx, wy, wz; in vtkVolumeTextureMapper3DComputeGradients() local
500 for ( z = z_start; z < z_limit; z++ ) in vtkVolumeTextureMapper3DComputeGradients()
502 floc[2] = z*sampleRate[2]; in vtkVolumeTextureMapper3DComputeGradients()
505 wz = floc[2] - loc[2]; in vtkVolumeTextureMapper3DComputeGradients()
[all …]
/dports/math/lis/lis-2.0.30/src/precon/
H A Dlis_precon_iluc.c938 LIS_SCALAR *z,*w,*tmp,wz[9],lu[9]; in lis_precon_create_iluc_bsr() local
1602 D->value[jj] -= z[jj]*wz[0]; in lis_precon_create_iluc_bsr()
1609 D->value[4*jj+0] -= z[4*jj+0]*wz[0] + z[4*jj+2]*wz[1]; in lis_precon_create_iluc_bsr()
1610 D->value[4*jj+1] -= z[4*jj+1]*wz[0] + z[4*jj+3]*wz[1]; in lis_precon_create_iluc_bsr()
1611 D->value[4*jj+2] -= z[4*jj+0]*wz[2] + z[4*jj+2]*wz[3]; in lis_precon_create_iluc_bsr()
1612 D->value[4*jj+3] -= z[4*jj+1]*wz[2] + z[4*jj+3]*wz[3]; in lis_precon_create_iluc_bsr()
1693 D->value[jj] -= z[jj]*wz[0]; in lis_precon_create_iluc_bsr()
1701 D->value[4*jj+0] -= z[4*jj+0]*wz[0] + z[4*jj+2]*wz[1]; in lis_precon_create_iluc_bsr()
1702 D->value[4*jj+1] -= z[4*jj+1]*wz[0] + z[4*jj+3]*wz[1]; in lis_precon_create_iluc_bsr()
1703 D->value[4*jj+2] -= z[4*jj+0]*wz[2] + z[4*jj+2]*wz[3]; in lis_precon_create_iluc_bsr()
[all …]
/dports/games/xonotic/Xonotic/source/qcsrc/lib/warpzone/
H A Dcommon.qc205 entity wz;
252 if(wz)
347 entity wz;
377 if(wz)
518 roll = ang.z;
519 ang.z = 0;
527 ang.z = roll;
554 roll = ang.z;
555 ang.z = 0;
561 ang.z = roll;
[all …]
/dports/games/openjk/OpenJK-07675e2/codemp/rd-vanilla/
H A Dtr_WorldEffects.cpp415 bit = (z & 31); in ConvertToCell()
416 z >>= 5; in ConvertToCell()
486 for (int wz=0; wz<mWeatherZones.size(); wz++) in Reset() local
582 for(z = 0; z < wz.mDepth; z++) in Cache()
616 wz.mPointCache[((z * wz.mWidth * wz.mHeight) + (y * wz.mWidth) + x)] |= bit; in Cache()
653 wz.ConvertToCell(pos, x, y, z, bit); in PointOutside()
654 return wz.CellOutside(x, y, z, bit); in PointOutside()
673 wz.ConvertToCell(pos, x, y, z, bit); in PointOutside()
676 return (wz.CellOutside(x, y, z, bit)); in PointOutside()
692 if (!wz.CellOutside(mXCell, mYCell, z, mZBit)) in PointOutside()
[all …]
/dports/science/nwchem/nwchem-7b21660b82ebd85ef659f6fba7e1e73433b0bd0a/contrib/marat/rotate/
H A Dmain.f418 double precision wx,wy,wz local
432 uz=u*z
438 wz=w*z
447 f1 = ux+vy+wz
457 z = (c*(u2+v2)-w*(au+bv-f1))*(1-ca)+d2*z*ca+
459 z = z/d2
468 double precision wx,wy,wz local
478 wz=w*z
481 x=u*(ux+vy+wz)+(x*(v*v+w*w)-u*(vy+wz))*ca+(-wy+vz)*sa
482 y=v*(ux+vy+wz)+(y*(u*u+w*w)-v*(ux+wz))*ca+(wx-uz)*sa
[all …]
/dports/science/nwchem-data/nwchem-7.0.2-release/contrib/marat/rotate/
H A Dmain.f418 double precision wx,wy,wz local
432 uz=u*z
438 wz=w*z
447 f1 = ux+vy+wz
457 z = (c*(u2+v2)-w*(au+bv-f1))*(1-ca)+d2*z*ca+
459 z = z/d2
468 double precision wx,wy,wz local
478 wz=w*z
481 x=u*(ux+vy+wz)+(x*(v*v+w*w)-u*(vy+wz))*ca+(-wy+vz)*sa
482 y=v*(ux+vy+wz)+(y*(u*u+w*w)-v*(ux+wz))*ca+(wx-uz)*sa
[all …]
/dports/emulators/ppsspp-qt5/ppsspp-1.12.3/Common/Math/lin/
H A Dmatrix4x4.h17 float wx, wy, wz, ww; member
25 const Vec3 move() const {return Vec3(wx, wy, wz);} in move()
56 wz = trans.z; in setTranslation()
101 xz = xz * scale.z + xw * trans.z; in translateAndScale()
105 yz = yz * scale.z + yw * trans.z; in translateAndScale()
109 zz = zz * scale.z + zw * trans.z; in translateAndScale()
113 wz = wz * scale.z + ww * trans.z; in translateAndScale()
/dports/emulators/ppsspp/ppsspp-1.12.3/Common/Math/lin/
H A Dmatrix4x4.h17 float wx, wy, wz, ww; member
25 const Vec3 move() const {return Vec3(wx, wy, wz);} in move()
56 wz = trans.z; in setTranslation()
101 xz = xz * scale.z + xw * trans.z; in translateAndScale()
105 yz = yz * scale.z + yw * trans.z; in translateAndScale()
109 zz = zz * scale.z + zw * trans.z; in translateAndScale()
113 wz = wz * scale.z + ww * trans.z; in translateAndScale()
/dports/emulators/libretro-ppsspp/ppsspp-1.12.3/Common/Math/lin/
H A Dmatrix4x4.h17 float wx, wy, wz, ww; member
25 const Vec3 move() const {return Vec3(wx, wy, wz);} in move()
56 wz = trans.z; in setTranslation()
101 xz = xz * scale.z + xw * trans.z; in translateAndScale()
105 yz = yz * scale.z + yw * trans.z; in translateAndScale()
109 zz = zz * scale.z + zw * trans.z; in translateAndScale()
113 wz = wz * scale.z + ww * trans.z; in translateAndScale()
/dports/games/dhewm3/dhewm3-1.5.1/neo/idlib/math/
H A DRotation.cpp54 return idQuat( vec.x * s, vec.y * s, vec.z * s, c ); in ToQuat()
63 float wx, wy, wz; in ToMat3() local
67 float a, c, s, x, y, z; in ToMat3() local
78 z = vec[2] * s; in ToMat3()
82 z2 = z + z; in ToMat3()
90 zz = z * z2; in ToMat3()
94 wz = c * z2; in ToMat3()
97 axis[ 0 ][ 1 ] = xy - wz; in ToMat3()
100 axis[ 1 ][ 0 ] = xy + wz; in ToMat3()
/dports/games/openjk/OpenJK-07675e2/code/rd-vanilla/
H A Dtr_WorldEffects.cpp485 bit = (z & 31); in ConvertToCell()
486 z >>= 5; in ConvertToCell()
561 for (int wz=0; wz<mWeatherZones.size(); wz++) in Reset() local
751 for(z = 0; z < wz.mDepth; z++) in Cache()
785 wz.mPointCache[((z * wz.mWidth * wz.mHeight) + (y * wz.mWidth) + x)] |= bit; in Cache()
830 wz.ConvertToCell(pos, x, y, z, bit); in PointOutside()
831 return wz.CellOutside(x, y, z, bit); in PointOutside()
850 wz.ConvertToCell(pos, x, y, z, bit); in PointOutside()
853 return (wz.CellOutside(x, y, z, bit)); in PointOutside()
869 if (!wz.CellOutside(mXCell, mYCell, z, mZBit)) in PointOutside()
[all …]

12345678910>>...63