Home
last modified time | relevance | path

Searched refs:SQR (Results 251 – 275 of 1451) sorted by relevance

1...<<11121314151617181920>>...59

/dports/games/openlierox/OpenLieroX/src/common/
H A DIpToCountryDB.cpp88 …double a = SQR(sin(dlat/2)) + cos(DEG2RAD(place1.latitude)) * cos(DEG2RAD(place2.latitude)) * SQR(… in GetDistance()
/dports/biology/cufflinks/cufflinks-2.2.1-89-gdc3b0cb/src/locfit/
H A Ddensity.c103 if (i==j) resp1[z*p+z] = w1*SQR(sca[i])*SQR(sca[i]);
105 { resp1[z*p+z] = w0*SQR(sca[i])*SQR(sca[j]);
106 resp1[k*p+l] = resp1[k+p*l] = w0/4*SQR(sca[i])*SQR(sca[j]);
153 { resp1[i] = resp1[(d+1)*i] = cf[i]*SQR(h*sca[i-1])*g[1];
155 { resp1[(d+1)*i+j] = (i==j) ? g[3]*SQR(h*sca[i-1]) : 0;
156 resp1[(d+1)*i+j] += g[2]*SQR(h*h*sca[i-1]*sca[j-1])*cf[i]*cf[j];
251 { C[i*d+i] = SQR(GFACT/(h*sca[i]))-cf[m1++];
/dports/science/cantera/cantera-2.5.1-611-gc4d6ecc15/ext/sundials/examples/cvodes/serial/
H A DcvsKrylovDemo_ls.c57 #ifndef SQR
58 #define SQR(A) ((A)*(A)) macro
353 data->hdco = KH/SQR(data->dx); in InitUserData()
355 data->vdco = (ONE/SQR(data->dy))*KV0; in InitUserData()
391 cy = SQR(RCONST(0.1)*(y - YMID)); in SetInitialProfiles()
392 cy = ONE - cy + RCONST(0.5)*SQR(cy); in SetInitialProfiles()
395 cx = SQR(RCONST(0.1)*(x - XMID)); in SetInitialProfiles()
396 cx = ONE - cx + RCONST(0.5)*SQR(cx); in SetInitialProfiles()
/dports/graphics/rawtherapee/rawtherapee-5.8/rtengine/
H A Dimprocfun.cc1536 Chprov1 = sqrtf (SQR (aa) + SQR (bb)) / 327.68f; in ciecam_02float()
1600 Chprov1 = sqrtf (SQR (aa) + SQR (bb)) / 327.68f; in ciecam_02float()
1877 Chprov1 = sqrtf (SQR (aa) + SQR (bb)) / 327.68f; in ciecam_02float()
1940 Chprov1 = sqrtf (SQR (aa) + SQR (bb)) / 327.68f; in ciecam_02float()
3072 …L = (1.f - valparam) * L + valparam * (1.f - SQR (SQR (SQR (SQR (1.f - min (L, 1.0f)))))); // SQR … in rgbProc()
4532 CC = sqrt (SQR (atmp) + SQR (btmp)) / 327.68f; in chromiLuminanceCurve()
4537 CC = sqrt (SQR (atmp) + SQR (btmp)) / 327.68f; in chromiLuminanceCurve()
4587 float Chprov2 = sqrt (SQR (atmp) + SQR (btmp)) / 327.68f; in chromiLuminanceCurve()
4748 float chroma = sqrt (SQR (atmp) + SQR (btmp) + 0.001f); in chromiLuminanceCurve()
4852 float chroma = sqrt (SQR (atmp) + SQR (btmp) + 0.001f); in chromiLuminanceCurve()
[all …]
/dports/cad/opencascade/opencascade-7.6.0/src/math/
H A Dmath_Powell.cxx32 static inline Standard_Real SQR (const Standard_Real a) in SQR() function
214 SQR(PreviousMinimum-TheMinimum -del)-del* in Perform()
215 SQR(PreviousMinimum-fptt); in Perform()
/dports/graphics/photivo/photivo/ReferenceMaterial/RawTherapee/
H A Dcfa_linedn_RT - 20101226.cc46 #define SQR(x) ((x)*(x)) macro
89 …float noisevar=SQR(3*noise*65535); // _noise_ (as a fraction of saturation) is input to the algori… in cfa_linedn()
195 linehvar[2*ey+ex] += SQR(dctblock[2*ey+ex][0][i]); in cfa_linedn()
196 linevvar[2*ey+ex] += SQR(dctblock[2*ey+ex][i][0]); in cfa_linedn()
201 coeffsq = SQR(dctblock[2*ey+ex][i][0]);//vertical in cfa_linedn()
203 coeffsq = SQR(dctblock[2*ey+ex][0][i]);//horizontal in cfa_linedn()
/dports/graphics/openshadinglanguage/OpenShadingLanguage-Release-1.11.15.0/src/testrender/
H A Dshading.cpp520 static float SQR(float x) { in SQR() function
525 float cosTheta2 = SQR(w.z); in evalLambda()
527 float cosPhi2st2 = SQR(w.x * xalpha); in evalLambda()
528 float sinPhi2st2 = SQR(w.y * yalpha); in evalLambda()
546 float cosPhi2st2 = SQR(Hr.x / xalpha); in evalD()
547 float sinPhi2st2 = SQR(Hr.y / yalpha); in evalD()
548 float cosThetaM2 = SQR(cosThetaM); in evalD()
549 float cosThetaM4 = SQR(cosThetaM2); in evalD()
572 float invnorm = 1 / sqrtf(SQR(swo.x) + SQR(swo.y)); in sampleMicronormal()
/dports/graphics/py-openshadinglanguage/OpenShadingLanguage-Release-1.11.15.0/src/testrender/
H A Dshading.cpp520 static float SQR(float x) { in SQR() function
525 float cosTheta2 = SQR(w.z); in evalLambda()
527 float cosPhi2st2 = SQR(w.x * xalpha); in evalLambda()
528 float sinPhi2st2 = SQR(w.y * yalpha); in evalLambda()
546 float cosPhi2st2 = SQR(Hr.x / xalpha); in evalD()
547 float sinPhi2st2 = SQR(Hr.y / yalpha); in evalD()
548 float cosThetaM2 = SQR(cosThetaM); in evalD()
549 float cosThetaM4 = SQR(cosThetaM2); in evalD()
572 float invnorm = 1 / sqrtf(SQR(swo.x) + SQR(swo.y)); in sampleMicronormal()
/dports/astro/nightfall/nightfall-1.92/
H A DLightFlux.c61 ScaledArea = SurfPtr->area * SQR(OrbPtr->Dist); in BBFlux()
132 ScaleFactor = SQR(OrbPtr->Dist); in ModelFlux()
H A DLightLib.c1054 r1 = sqrt(SQR(Bptr->RLag1) + (y*y)); in RocheYPerpendL1()
1055 r2 = sqrt(SQR(1.0-Bptr->RLag1) + (y*y)); in RocheYPerpendL1()
1059 + ((Mq+1.0)/2.0) * (SQR(Bptr->RLag1) + (y*y)); in RocheYPerpendL1()
1187 r2 = sqrt( SQR(x-1.0) + (y*y) ); in RocheXYPrimary()
1282 RadPower = SQR(RadPower); /* r^6 */ in VolOfR()
1287 RadPower = RadPower*SQR(r_0); /* r^8 */ in VolOfR()
1328 double Eval = - 1.0/(x*x) + Mq * ( 1.0/SQR(x-1) - 1.0 ) + F*F*x*( Mq + 1); in LagrangeOne()
1349 + Mq * ( (1.0-x)/((x-1.0)*SQR(x-1.0)) - 1.0 ) in LagrangeTwo()
1371 + Mq * ( (1.0)/SQR(1.0-x) - 1.0 ) in LagrangeThree()
/dports/devel/z88dk/z88dk/libsrc/_DEVELOPMENT/math/float/math48/z80/core/
H A Dmm48_ln.asm32 ;Z=Y*SQR(2)/2
69 ; AC'= SQR(2)/2
/dports/science/afni/afni-AFNI_21.3.16/src/
H A Dtfim.c127 q1 = SQR(sdar1[ii]) * n1i ; /* qi = sigi^2 / numi */ in main()
128 q2 = SQR(sdar2[ii]) * n2i ; in main()
131 dofar[ii] = SQR(q1+q2) / ( q1*q1*n11i + q2*q2*n21i ) ; in main()
182 corar[ii] = tspar[ii] / sqrt( doff + SQR(tspar[ii]) ) ; in main()
192 cth = thr / sqrt( doff + SQR(thr) ) ; in main()
/dports/science/cantera/cantera-2.5.1-611-gc4d6ecc15/ext/sundials/examples/cvode/serial/
H A DcvKrylovDemo_ls.c59 #ifndef SQR
60 #define SQR(A) ((A)*(A)) macro
461 data->hdco = KH/SQR(data->dx); in InitUserData()
463 data->vdco = (ONE/SQR(data->dy))*KV0; in InitUserData()
499 cy = SQR(RCONST(0.1)*(y - YMID)); in SetInitialProfiles()
500 cy = ONE - cy + RCONST(0.5)*SQR(cy); in SetInitialProfiles()
503 cx = SQR(RCONST(0.1)*(x - XMID)); in SetInitialProfiles()
504 cx = ONE - cx + RCONST(0.5)*SQR(cx); in SetInitialProfiles()
/dports/math/sundials/sundials-5.7.0/examples/cvodes/serial/
H A DcvsKrylovDemo_ls.c59 #ifndef SQR
60 #define SQR(A) ((A)*(A)) macro
479 data->hdco = KH/SQR(data->dx); in InitUserData()
481 data->vdco = (ONE/SQR(data->dy))*KV0; in InitUserData()
517 cy = SQR(RCONST(0.1)*(y - YMID)); in SetInitialProfiles()
518 cy = ONE - cy + RCONST(0.5)*SQR(cy); in SetInitialProfiles()
521 cx = SQR(RCONST(0.1)*(x - XMID)); in SetInitialProfiles()
522 cx = ONE - cx + RCONST(0.5)*SQR(cx); in SetInitialProfiles()
/dports/graphics/netpbm/netpbm-10.91.01/analyzer/
H A Dpgmtexture.c153 float const sqrdx = SQR(RADIX); in mkbalanced()
369 s = sign(sqrt(SQR(p) + SQR(q) + SQR(r)), p); in hessenberg()
460 bigsum += SQR(n) * sum; in f2_contrast()
501 sumSqrx += px[i] * SQR(i); in f3_corr()
505 stddevx = sqrt(sumSqrx - (SQR(meanx))); in f3_corr()
692 sumSqr += SQR(pxpy[i]); in f10_dvar()
694 sqrNg = SQR(ng); in f10_dvar()
695 var = (sqrNg * sumSqr - SQR(sum)) / SQR(sqrNg); in f10_dvar()
/dports/science/lammps/lammps-stable_29Sep2021/src/REAXFF/
H A Dreaxff_multi_body.cpp90 75 * p_lp2 * workspace->Delta_lp[i] * expvd2 * SQR(inv_expvd2); in Atom_Energy()
114 data->my_en.e_lp += e_lph = p_lp3 * SQR(vov3-3.0); in Atom_Energy()
175 p_ovun4 * exp_ovun1 * SQR(inv_exp_ovun1); in Atom_Energy()
203 p_ovun4 * exp_ovun1 * SQR(inv_exp_ovun1) + CEunder2; in Atom_Energy()
/dports/science/lammps/lammps-stable_29Sep2021/src/OPENMP/
H A Dreaxff_multi_body_omp.cpp115 75 * p_lp2 * workspace->Delta_lp[i] * expvd2 * SQR(inv_expvd2); in Atom_EnergyOMP()
139 total_Elp += e_lph = p_lp3 * SQR(vov3-3.0); in Atom_EnergyOMP()
202 p_ovun4 * exp_ovun1 * SQR(inv_exp_ovun1); in Atom_EnergyOMP()
229 p_ovun4 * exp_ovun1 * SQR(inv_exp_ovun1) + CEunder2; in Atom_EnergyOMP()
/dports/games/0ad/0ad-0.0.23b-alpha/source/maths/
H A DQuaternion.cpp290 float lensqrd=SQR(m_V.X)+SQR(m_V.Y)+SQR(m_V.Z)+SQR(m_W); in Normalize()
/dports/graphics/gegl/gegl-0.4.34/operations/common-gpl3+/
H A Dedge-laplace.c39 #define SQR(x) ((x)*(x)) macro
85 buf1 = g_new (gfloat, SQR (CHUNK_SIZE + LAPLACE_RADIUS * 2) * 4); in process()
86 buf2 = g_new (gfloat, SQR (CHUNK_SIZE + LAPLACE_RADIUS * 2) * 4); in process()
87 buf3 = g_new (gfloat, SQR (CHUNK_SIZE) * 4); in process()
/dports/graphics/photoflow/PhotoFlow-8472024f/src/operations/
H A Draw_hl_reco.cc168 sum[i] += SQR(lab[i][c]); in HLRecovery_blend()
192 float rfrac = SQR((min(clip[0], in[col]) - fixpt) / (clip[0] - fixpt)); in HLRecovery_blend()
197 float gfrac = SQR((min(clip[1], in[col+1]) - fixpt) / (clip[1] - fixpt)); in HLRecovery_blend()
202 float bfrac = SQR((min(clip[2], in[col+2]) - fixpt) / (clip[2] - fixpt)); in HLRecovery_blend()
/dports/graphics/gimp-app/gimp-2.10.30/app/propgui/
H A Dgimppropgui-supernova.c56 radius = sqrt (SQR (x2 - x1) + SQR (y2 - y1)); in line_callback()
H A Dgimppropgui-motion-blur-linear.c54 length = sqrt (SQR (x2 - x1) + SQR (y2 - y1)); in line_callback()
/dports/math/fftw-float/fftw-2.1.5/tests/
H A Dtest_main.c303 a = sqrt(SQR(c_re(A[i * astride]) - c_re(B[i * bstride])) + in compute_error_complex()
304 SQR(c_im(A[i * astride]) - c_im(B[i * bstride]))); in compute_error_complex()
305 mag = 0.5 * (sqrt(SQR(c_re(A[i * astride])) in compute_error_complex()
306 + SQR(c_im(A[i * astride]))) + in compute_error_complex()
307 sqrt(SQR(c_re(B[i * bstride])) in compute_error_complex()
308 + SQR(c_im(B[i * bstride])))) + TOLERANCE; in compute_error_complex()
/dports/math/fftw/fftw-2.1.5/tests/
H A Dtest_main.c303 a = sqrt(SQR(c_re(A[i * astride]) - c_re(B[i * bstride])) + in compute_error_complex()
304 SQR(c_im(A[i * astride]) - c_im(B[i * bstride]))); in compute_error_complex()
305 mag = 0.5 * (sqrt(SQR(c_re(A[i * astride])) in compute_error_complex()
306 + SQR(c_im(A[i * astride]))) + in compute_error_complex()
307 sqrt(SQR(c_re(B[i * bstride])) in compute_error_complex()
308 + SQR(c_im(B[i * bstride])))) + TOLERANCE; in compute_error_complex()
/dports/math/alberta/alberta3-920315ae1bbfd1b1fb6672d916619ac37a411e95/add_ons/albertasystems/AlbertaNum/Common/
H A Dellipt_est.cc242 vals[iq]= SQR(n_A_grd_uh); in heat_neumann_res2()
295 val += quad_fast_uh->w[iq]*SQR(res); in calc()
306 val += elquad->w[iq]*SQR(riq); in calc()
471 C0 = C[0] > 1.e-25 ? SQR(C[0]) : 0.0; in get_C()
472 C1 = C[1] > 1.e-25 ? SQR(C[1]) : 0.0; in get_C()
473 C2 = C[2] > 1.e-25 ? SQR(C[2]) : 0.0; in get_C()

1...<<11121314151617181920>>...59