Home
last modified time | relevance | path

Searched refs:d2y (Results 1 – 25 of 208) sorted by relevance

123456789

/dports/math/p5-Math-Utils/Math-Utils-1.14/t/
H A D17-derivative-eval.t10 my(@coef, $y, $dy, $d2y);
26 &$fltcmp($d2y, 0) == 0),
42 &$fltcmp($d2y, 0) == 0),
57 &$fltcmp($d2y, 300) == 0),
71 &$fltcmp($d2y, 432) == 0),
85 &$fltcmp($d2y, 70) == 0),
99 &$fltcmp($d2y, -8912) == 0),
113 &$fltcmp($d2y, 145114) == 0),
120 &$fltcmp($d2y, -7510) == 0),
127 &$fltcmp($d2y, -390) == 0),
[all …]
/dports/science/quantum-espresso/q-e-qe-6.7.0/upflib/
H A Dsplinelib.f9035 REAL(DP), INTENT(OUT) :: d2y(:) local
47 d2y(1) = startd
61 d2y(ydim) = 0
65 d2y(k) = d2y(k) * d2y(k+1) + u(k)
102 ( ( a**3 - a ) * d2y(klo) + ( b**3 - b ) * d2y(khi) ) * &
225 ALLOCATE( d2y( old_dim ) )
227 d2y = 0
237 DEALLOCATE( d2y )
273 ALLOCATE( d2y( old_dim ) )
277 d2y = 0
[all …]
/dports/science/qmcpack/qmcpack-3.11.0/src/QMCTools/ppconvert/src/
H A DCubicSpline.cc28 d2y[0] = 0.0; // Use "Natural" boundary conditions--ie d^2y/dr^2 = 0 in Update()
32 d2y[0] = -0.5; in Update()
36 d2y[x.NumPoints()-1] = 0.0; in Update()
41 double p = sig *d2y[i-1]+2.0; in Update()
42 d2y[i] = (sig-1.0)/p; in Update()
58 d2y[N-1] = (Un-Qn*U[N-2])/(Qn*d2y[N-2]+1.0); in Update()
61 d2y[k] = d2y[k]*d2y[k+1] + U[k]; in Update()
H A DCubicSpline.h36 std::vector<double> d2y; variable
76 d2y.resize(grid.NumPoints()); in Init()
161 …return (a * y[low] + b * y[hi] + ((a * a * a - a) * d2y[low] + (b * b * b - b) * d2y[hi]) * (h * h… in operator()
189 …] - y[low]) * hinv + (h * sixinv) * ((3.0 * b * b - 1.0) * d2y[hi] - (3.0 * a * a - 1.0) * d2y[low… in Deriv()
215 return (a * d2y[low] + b * d2y[hi]); in Deriv2()
239 return ((d2y[hi] - d2y[low]) / h); in Deriv3()
/dports/games/krank/krank-07/levels/
H A Dlevel021.py22 d3, d3y = (d1+d2)/2, (d1+d2y)/2
28 (cx+d1, cy+d2y),
30 (cx+d2, cy+d2y),
38 (cx-d1, cy+d2y),
40 (cx-d2, cy+d2y),
48 (cx+d1, cy-d2y),
50 (cx+d2, cy-d2y),
58 (cx-d1, cy-d2y),
60 (cx-d2, cy-d2y),
75 anchor = [(cx, cy+70), (cx, cy+d2y)]
[all …]
/dports/science/qmcpack/qmcpack-3.11.0/src/QMCTools/ppconvert/src/common/
H A DCubicSplineCommon.h38 Array<double, 1> d2y; variable
78 d2y.resize(grid->NumPoints); in Init()
130 d2y.resize(NumParams); in Read()
194 …return (a * y(low) + b * y(hi) + ((a * a * a - a) * d2y(low) + (b * b * b - b) * d2y(hi)) * (h * h… in operator()
222 …) - y(low)) * hinv + (h * sixinv) * ((3.0 * b * b - 1.0) * d2y(hi) - (3.0 * a * a - 1.0) * d2y(low… in Deriv()
248 return (a * d2y(low) + b * d2y(hi)); in Deriv2()
272 return ((d2y(hi) - d2y(low)) / h); in Deriv3()
H A DCubicSplineCommon.cc26 CubicSplineSolve(x.data(), y.data(), N, StartDeriv, EndDeriv, d2y.data()); in Update()
117 d2y.resize(spline.d2y.shape()); d2y = spline.d2y; in operator =()
/dports/math/gnuplot/gnuplot-5.4.1/src/
H A Dcontour.c994 d2y[0] = 0.; in put_contour_cubic()
996 d2y[1] = 0.; in put_contour_cubic()
1001 free(d2y); in put_contour_cubic()
1125 d2y[num_pts - 1] = d2y[0]; in gen_cubic_spline()
1136 d2y[i] = (d2y[i + 1] - d2y[i]) * 6.; in gen_cubic_spline()
1173 d2y[i] = d2y[i - 1]; in gen_cubic_spline()
1177 d2y[0] = d2y[n]; in gen_cubic_spline()
1180 d2y[0] = d2y[1]; /* first and last interval */ in gen_cubic_spline()
1182 d2y[n + 1] = d2y[n]; in gen_cubic_spline()
1231 dy0 = (d2y[i + 1] + 2 * d2y[i]) / 6.; in intp_cubic_spline()
[all …]
/dports/math/gnuplot-lite/gnuplot-5.4.1/src/
H A Dcontour.c994 d2y[0] = 0.; in put_contour_cubic()
996 d2y[1] = 0.; in put_contour_cubic()
1001 free(d2y); in put_contour_cubic()
1125 d2y[num_pts - 1] = d2y[0]; in gen_cubic_spline()
1136 d2y[i] = (d2y[i + 1] - d2y[i]) * 6.; in gen_cubic_spline()
1173 d2y[i] = d2y[i - 1]; in gen_cubic_spline()
1177 d2y[0] = d2y[n]; in gen_cubic_spline()
1180 d2y[0] = d2y[1]; /* first and last interval */ in gen_cubic_spline()
1182 d2y[n + 1] = d2y[n]; in gen_cubic_spline()
1231 dy0 = (d2y[i + 1] + 2 * d2y[i]) / 6.; in intp_cubic_spline()
[all …]
/dports/math/gnuplot-tex-extras/gnuplot-5.2.8/src/
H A Dcontour.c999 d2y[0] = 0.; in put_contour_cubic()
1001 d2y[1] = 0.; in put_contour_cubic()
1006 free(d2y); in put_contour_cubic()
1130 d2y[num_pts - 1] = d2y[0]; in gen_cubic_spline()
1141 d2y[i] = (d2y[i + 1] - d2y[i]) * 6.; in gen_cubic_spline()
1178 d2y[i] = d2y[i - 1]; in gen_cubic_spline()
1182 d2y[0] = d2y[n]; in gen_cubic_spline()
1185 d2y[0] = d2y[1]; /* first and last interval */ in gen_cubic_spline()
1187 d2y[n + 1] = d2y[n]; in gen_cubic_spline()
1236 dy0 = (d2y[i + 1] + 2 * d2y[i]) / 6.; in intp_cubic_spline()
[all …]
/dports/science/py-scipy/scipy-1.7.1/doc/source/tutorial/examples/
H A Dnewton_krylov_preconditioning.py51 d2y = zeros_like(P)
57 d2y[:,1:-1] = (P[:,2:] - 2*P[:,1:-1] + P[:,:-2])/hy/hy
58 d2y[:,0] = (P[:,1] - 2*P[:,0] + P_bottom)/hy/hy
59 d2y[:,-1] = (P_top - 2*P[:,-1] + P[:,-2])/hy/hy
61 return d2x + d2y + 5*cosh(P).mean()**2
/dports/science/quantum-espresso/q-e-qe-6.7.0/PP/src/
H A Dplotband.f90685 real :: d2y(nin) local
702 real, INTENT(out):: d2y(n) local
708 d2y(1)=-0.5
713 p=sig*d2y(i-1)+2.0
714 d2y(i)=(sig-1.0)/p
721 d2y(n)=(un-qn*work(n-1))/(qn*d2y(n-1)+1.0)
723 d2y(k)=d2y(k)*d2y(k+1)+work(k)
736 d2y(nspline) local
745 PRINT *, d2y
769 + ( (a**3-a)*d2y(klo) + (b**3-b)*d2y(khi) )*h*h/6.0
[all …]
H A Dpaw_postproc.f9038 REAL(DP),ALLOCATABLE :: wsp_lm(:,:,:), ylm_posi(:,:), d1y(:), d2y(:) local
96 ALLOCATE( d1y(upf(i%t)%kkbeta), d2y(upf(i%t )%kkbeta) )
101 CALL radial_gradient(d1y, d2y, g(i%t)%r, upf(i%t)%kkbeta, 1)
104 second = d2y(1) ! second derivative in first point
110 DEALLOCATE(d1y, d2y)
/dports/science/lammps/lammps-stable_29Sep2021/src/MGPT/
H A Dmgpt_splinetab.cpp81 void evalcubic(double p[4],double x,double *y,double *dy,double *d2y) { in evalcubic() argument
91 *d2y = 2.0*(t3 + x*p[3]); in evalcubic()
95 double x,double *y,double *dy,double *d2y) { in evalspline() argument
112 *d2y = 2*p[2] + xhat*6*p[3]; in evalspline()
115 *d2y *= dxinv*dxinv; in evalspline()
124 *d2y = 2.0*(t3 + xhat*p[3])*(dxinv*dxinv); in evalspline()
H A Dmgpt_splinetab.h53 double x,double *y,double *dy,double *d2y);
60 void evalcubic(double p[4],double x,double *y,double *dy,double *d2y);
/dports/games/jfk/jfk-0.1.1/src/server/
H A Dcollision.cc49 double d2y = y3 - y1; in coll() local
54 double sc1 = d1x * d2x + d1y * d2y; in coll()
64 sqr_h = ((d2x * d2x + d2y * d2y) * (d1x * d1x + d1y * d1y) - in coll()
65 (d1x * d2x + d1y * d2y) * (d1x * d2x + d1y * d2y)) / in coll()
70 sqr_h = d2x * d2x + d2y * d2y; in coll()
/dports/math/gsl/gsl-2.7/doc/examples/
H A Dgaussfilt2.c19 gsl_vector *d2y = gsl_vector_alloc(N); /* second derivative filtered vector */ in main() local
36 gsl_filter_gaussian(GSL_FILTER_END_PADVALUE, alpha, 2, x, d2y, gauss_p); in main()
44 double d2yi = gsl_vector_get(d2y, i); in main()
66 gsl_vector_free(d2y); in main()
/dports/cad/opencascade/opencascade-7.6.0/tests/geometry/
H A Dbegin27 2dcvalue cc u x y dx dy d2x d2y ;
33 puts "d2_$i [dval d2x] [dval d2y]";
37 point d2_$i d2x d2y
53 cvalue cc u x y z dx dy dz d2x d2y d2z ;
58 puts "d2_$i [dval d2x] [dval d2y] [dval d2z]";
61 point d2_$i d2x d2y d2z
/dports/games/duel/duel/src/libDazzle/
H A Dpixels.cpp84 long u,s,v,d1x,d1y,d2x,d2y,m,n; in drawline() local
93 d2y = 0; in drawline()
100 d2y = sgn(v); in drawline()
123 b += d2y; in drawline()
/dports/editors/ted/Ted-2.23/appUtil/
H A DgeoQuadTree.c423 long d2y; in qnGetNearest() local
431 d2y= y- qn->qnY; d2y= d2y* d2y; in qnGetNearest()
432 d2= d2x+ d2y; in qnGetNearest()
443 d[1]= d2y; d[2]= d2x; in qnGetNearest()
447 d[1]= d2x; d[2]= d2y; in qnGetNearest()
455 d[1]= d2x; d[2]= d2y; in qnGetNearest()
459 d[1]= d2y; d[2]= d2x; in qnGetNearest()
467 d[1]= d2y; d[2]= d2x; in qnGetNearest()
471 d[1]= d2x; d[2]= d2y; in qnGetNearest()
479 d[1]= d2x; d[2]= d2y; in qnGetNearest()
[all …]
/dports/science/dakota/dakota-6.13.0-release-public.src-UI/packages/surfpack/src/surfaces/
H A DKrigingModel.cpp230 MtxDbl d2y(ndims, ndims, 0.0); in hessian() local
233 d2y(j,j)=nkm_d2y(k,0); in hessian()
236 d2y(i,j) = nkm_d2y(k,0); in hessian()
237 d2y(j,i) = d2y(i,j); in hessian()
242 return d2y; in hessian()
/dports/science/qmcpack/qmcpack-3.11.0/src/Numerics/
H A DCubicBspline.h143 inline value_type splint(point_type x, value_type& dy, value_type& d2y) in splint()
147 return interpolate(P[i0], P[i0 + 1], P[i0 + 2], P[i0 + 3], dy, d2y); in splint()
152 d2y = 0.0; in splint()
174 value_type& d2y) in interpolate()
179 d2y = GridDeltaInv2 * (tp[2] * (-p0 + 3.0 * p1 - 3.0 * p2 + p3) + tp[3] * (p0 - 2.0 * p1 + p2)); in interpolate()
/dports/audio/faust/faust-2.37.3/tools/physicalModeling/mesh2faust/vega/libraries/wildMagic/geometryQuery/
H A DverticesQueryFiltered.cpp106 double d2y = vec2[1] - test[1]; in toCircumsphere() local
117 double w2 = s2x*d2x + s2y*d2y + s2z*d2z; in toCircumsphere()
122 double len2 = sqrt(d2x*d2x+d2y*d2y+d2z*d2z+w2*w2); in toCircumsphere()
126 double det = det4(d0x, d0y, d0z, w0, d1x, d1y, d1z, w1, d2x, d2y, d2z, in toCircumsphere()
/dports/math/gecode/gecode-0916a1a/examples/
H A Dmagic-square.cpp82 IntVarArgs d2y(n); in MagicSquare() local
85 d2y[i] = m(n-i-1,i); in MagicSquare()
88 linear(*this, d2y, IRT_EQ, s, opt.ipl()); in MagicSquare()
/dports/misc/vxl/vxl-3.3.2/contrib/brl/bbas/bsol/
H A Dbsol_intrinsic_curve_2d.cxx366 double d2x=0, d2y=0; in computeCurvatures() local
369 d2y=(cdy-pdy)/dL; in computeCurvatures()
373 K=(d2y*cdx-d2x*cdy)/std::pow((std::pow(cdx,2)+std::pow(cdy,2)),3/2); in computeCurvatures()
375 … std::cout << d2x << ' ' << d2y << ' ' << dL << ' ' << cdx << ' ' << cdy << ' ' << K << std::endl; in computeCurvatures()
390 double d2x, d2y; in computeCurvatures() local
393 d2y=(cdy-pdy)/dL; in computeCurvatures()
396 d2x=d2y=0; in computeCurvatures()
401 K=(d2y*cdx-d2x*cdy)/std::pow((std::pow(cdx,2)+std::pow(cdy,2)),3/2); in computeCurvatures()

123456789