Home
last modified time | relevance | path

Searched refs:hinv (Results 1 – 25 of 269) sorted by relevance

1234567891011

/dports/science/liggghts/LIGGGHTS-PUBLIC-3.8.0-26-g6e873439/src/
H A Dsph_kernel_cubicspline.h60 inline double sph_kernel_cubicspline(double s, double h, double hinv);
61 inline double sph_kernel_cubicspline_der(double s, double h, double hinv);
72 inline double SPH_KERNEL_NS::sph_kernel_cubicspline(double s, double, double hinv)
76 return (0.079577*hinv*hinv*hinv * ((2.-s)*(2.-s)*(2.-s) - 4.*(1.-s)*(1.-s)*(1.-s)));
80 return (0.079577*hinv*hinv*hinv * ((2.-s)*(2.-s)*(2.-s)));
92 inline double SPH_KERNEL_NS::sph_kernel_cubicspline_der(double s, double, double hinv)
96 return (0.079577*hinv*hinv*hinv*hinv * (-3.*(2.-s)*(2.-s) + 12.*(1.-s)*(1.-s)));
100 return (0.079577*hinv*hinv*hinv*hinv * (-3.*(2.-s)*(2.-s)));
H A Dsph_kernel_cubicspline2D.h61 inline double sph_kernel_cubicspline2d(double s, double h, double hinv);
62 inline double sph_kernel_cubicspline2d_der(double s, double h, double hinv);
73 inline double SPH_KERNEL_NS::sph_kernel_cubicspline2d(double s, double, double hinv)
77 return (0.1136821*hinv*hinv * ((2.-s)*(2.-s)*(2.-s) - 4.*(1.-s)*(1.-s)*(1.-s)));
81 return (0.1136821*hinv*hinv * ((2.-s)*(2.-s)*(2.-s)));
93 inline double SPH_KERNEL_NS::sph_kernel_cubicspline2d_der(double s, double, double hinv)
97 return (0.1136821*hinv*hinv*hinv * (-3.*(2.-s)*(2.-s) + 12.*(1.-s)*(1.-s)));
101 return (0.1136821*hinv*hinv*hinv * (-3.*(2.-s)*(2.-s)));
H A Dsph_kernel_spiky.h61 inline double sph_kernel_spiky(double s, double h, double hinv);
62 inline double sph_kernel_spiky_der(double s, double h, double hinv);
74 inline double SPH_KERNEL_NS::sph_kernel_spiky(double s, double, double hinv)
78 return (0.07460388*hinv*hinv*hinv * (2.-s)*(2.-s)*(2.-s));
105 inline double SPH_KERNEL_NS::sph_kernel_spiky_der(double s, double, double hinv)
109 return (-0.223811639*hinv*hinv*hinv*hinv * (2.-s)*(2.-s));
H A Dsph_kernel_wendland.h61 inline double sph_kernel_wendland(double s, double h, double hinv);
62 inline double sph_kernel_wendland_der(double s, double h, double hinv);
73 inline double SPH_KERNEL_NS::sph_kernel_wendland(double s, double, double hinv)
75 return (0.417781726*hinv*hinv*hinv * (1.-0.5*s)*(1.-0.5*s)*(1.-0.5*s)*(1.-0.5*s) * (2.*s+1));
86 inline double SPH_KERNEL_NS::sph_kernel_wendland_der(double s, double, double hinv)
88 return (0.835563451*hinv*hinv*hinv*hinv * ((1-0.5*s)*(1-0.5*s)*(1-0.5*s)*((1-0.5*s)-(2.*s+1))));
H A Dsph_kernel_spiky2D.h61 inline double sph_kernel_spiky2d(double s, double h, double hinv);
62 inline double sph_kernel_spiky2d_der(double s, double h, double hinv);
73 inline double SPH_KERNEL_NS::sph_kernel_spiky2d(double s, double, double hinv)
77 return (0.09947183943*hinv*hinv * (2.-s)*(2.-s)*(2.-s));
93 inline double SPH_KERNEL_NS::sph_kernel_spiky2d_der(double s, double, double hinv)
97 return (-0.298415518297304*hinv*hinv*hinv * (2.-s)*(2.-s));
H A Dsph_kernel_wendland2D.h60 inline double sph_kernel_wendland2d(double s, double h, double hinv);
61 inline double sph_kernel_wendland2d_der(double s, double h, double hinv);
72 inline double SPH_KERNEL_NS::sph_kernel_wendland2d(double s, double, double hinv)
74 return (0.557042301*hinv*hinv * (1.-0.5*s)*(1.-0.5*s)*(1.-0.5*s)*(1.-0.5*s) * (2.*s+1));
85 inline double SPH_KERNEL_NS::sph_kernel_wendland2d_der(double s, double, double hinv)
87 return (1.114084602*hinv*hinv*hinv * ((1-0.5*s)*(1-0.5*s)*(1-0.5*s)*((1-0.5*s)-(2.*s+1))));
H A Dsph_kernels.h48 inline double sph_kernel(int id,double s,double h,double hinv);
49 inline double sph_kernel_der(int id,double s,double h,double hinv);
92 inline double SPH_KERNEL_NS::sph_kernel(int id,double s,double h,double hinv) in sph_kernel() argument
97 else if (kernel_id == id) return SPH_KERNEL_NS::SPHKernelCalculation(s,h,hinv); in sph_kernel()
106 inline double SPH_KERNEL_NS::sph_kernel_der(int id,double s,double h,double hinv) in sph_kernel_der() argument
111 else if (kernel_id == id) return SPH_KERNEL_NS::SPHKernelCalculationDer(s,h,hinv); in sph_kernel_der()
H A Dregion_prism.cpp171 hinv[0][0] = 1.0/h[0][0]; in RegPrism()
172 hinv[0][1] = -h[0][1] / (h[0][0]*h[1][1]); in RegPrism()
173 hinv[0][2] = (h[0][1]*h[1][2] - h[0][2]*h[1][1]) / (h[0][0]*h[1][1]*h[2][2]); in RegPrism()
174 hinv[1][1] = 1.0/h[1][1]; in RegPrism()
175 hinv[1][2] = -h[1][2] / (h[1][1]*h[2][2]); in RegPrism()
176 hinv[2][2] = 1.0/h[2][2]; in RegPrism()
275 double a = hinv[0][0]*(x-xlo) + hinv[0][1]*(y-ylo) + hinv[0][2]*(z-zlo); in inside()
276 double b = hinv[1][1]*(y-ylo) + hinv[1][2]*(z-zlo); in inside()
277 double c = hinv[2][2]*(z-zlo); in inside()
/dports/net/ladvd/ladvd-1.1.2/src/
H A Dsysinfo.c54 struct hinv *hinv, hinv_empty = {}; in sysinfo_fetch() local
60 hinv = &(sysinfo->hinv); in sysinfo_fetch()
182 read_line(SYSFS_HW_REVISION, hinv->hw_revision, len); in sysinfo_fetch()
183 read_line(SYSFS_FW_REVISION, hinv->fw_revision, len); in sysinfo_fetch()
184 read_line(SYSFS_SERIAL_NO, hinv->serial_number, len); in sysinfo_fetch()
186 read_line(SYSFS_MODEL_NAME, hinv->model_name, len); in sysinfo_fetch()
196 sysctl(mib, 2, hinv->hw_revision, &len, NULL, 0); in sysinfo_fetch()
201 sysctl(mib, 2, hinv->serial_number, &len, NULL, 0); in sysinfo_fetch()
206 sysctl(mib, 2, hinv->manufacturer, &len, NULL, 0); in sysinfo_fetch()
211 sysctl(mib, 2, hinv->model_name, &len, NULL, 0); in sysinfo_fetch()
[all …]
/dports/math/giacxcas/giac-1.6.0/examples/lewisw/
H A DlwHL4 hinv:=inverse(hilbert(40),rational_det);
5 hinv*h40;
8 hinv:=inverse(hilbert(70),rational_det);
9 hinv*h70;
14 purge(hinv);
/dports/net/ladvd/ladvd-1.1.2/src/proto/
H A Dlldp.c67 struct hinv *hinv; in lldp_packet() local
95 hinv = &(sysinfo->hinv); in lldp_packet()
345 PUSH_BYTES(hinv->hw_revision, strlen(hinv->hw_revision)) in lldp_packet()
358 PUSH_BYTES(hinv->fw_revision, strlen(hinv->fw_revision)) in lldp_packet()
371 PUSH_BYTES(hinv->sw_revision, strlen(hinv->sw_revision)) in lldp_packet()
384 PUSH_BYTES(hinv->serial_number, strlen(hinv->serial_number)) in lldp_packet()
397 PUSH_BYTES(hinv->manufacturer, strlen(hinv->manufacturer)) in lldp_packet()
405 if (strlen(hinv->model_name) > 0) { in lldp_packet()
410 PUSH_BYTES(hinv->model_name, strlen(hinv->model_name)) in lldp_packet()
418 if (strlen(hinv->asset_id) > 0) { in lldp_packet()
[all …]
/dports/science/qmcpack/qmcpack-3.11.0/src/QMCTools/ppconvert/src/
H A DCubicSpline.h156 double hinv = 1.0 / h; in operator() local
157 double a = (X[hi] - x) * hinv; in operator()
158 double b = (x - X[low]) * hinv; in operator()
184 double hinv = 1.0 / h; in Deriv() local
185 double a = (X[hi] - x) * hinv; in Deriv()
186 double b = (x - X[low]) * hinv; in Deriv()
189 …return ((y[hi] - y[low]) * hinv + (h * sixinv) * ((3.0 * b * b - 1.0) * d2y[hi] - (3.0 * a * a - 1… in Deriv()
212 double hinv = 1.0 / h; in Deriv2() local
213 double a = (X[hi] - x) * hinv; in Deriv2()
214 double b = (x - X[low]) * hinv; in Deriv2()
/dports/math/e-antic/e-antic-1.0.0-rc.13/libeantic/upstream/antic/fq_poly/profile/
H A Dp-compose_mod_preinv.c27 fq_poly_t f, g, h, hinv, res; in main() local
46 fq_poly_init(hinv, ctx); in main()
65 fq_poly_reverse(hinv, h, h->length, ctx); in main()
66 fq_poly_inv_series_newton(hinv, hinv, h->length, ctx); in main()
75 fq_poly_compose_mod_horner_preinv(res, f, g, h, hinv, ctx); in main()
83 fq_poly_compose_mod_brent_kung_preinv(res, f, g, h, hinv, ctx); in main()
/dports/math/e-antic/flint2-ae7ec89/fq_poly/profile/
H A Dp-compose_mod_preinv.c27 fq_poly_t f, g, h, hinv, res; in main() local
46 fq_poly_init(hinv, ctx); in main()
65 fq_poly_reverse(hinv, h, h->length, ctx); in main()
66 fq_poly_inv_series_newton(hinv, hinv, h->length, ctx); in main()
75 fq_poly_compose_mod_horner_preinv(res, f, g, h, hinv, ctx); in main()
83 fq_poly_compose_mod_brent_kung_preinv(res, f, g, h, hinv, ctx); in main()
/dports/math/flint2/flint-2.8.4/fq_poly/profile/
H A Dp-compose_mod_preinv.c27 fq_poly_t f, g, h, hinv, res; in main() local
46 fq_poly_init(hinv, ctx); in main()
65 fq_poly_reverse(hinv, h, h->length, ctx); in main()
66 fq_poly_inv_series_newton(hinv, hinv, h->length, ctx); in main()
75 fq_poly_compose_mod_horner_preinv(res, f, g, h, hinv, ctx); in main()
83 fq_poly_compose_mod_brent_kung_preinv(res, f, g, h, hinv, ctx); in main()
/dports/science/bagel/bagel-1.2.2/src/opt/
H A Dget_grad.cc187 auto hinv = make_shared<Matrix>(3,3); in get_euclidean_dist() local
190 hinv->element(0,0) = hdiag1 * hdiag2 - fmat->element(2,1) * fmat->element(2,1); in get_euclidean_dist()
191 hinv->element(1,1) = hdiag0 * hdiag2 - fmat->element(2,0) * fmat->element(2,0); in get_euclidean_dist()
192 hinv->element(2,2) = hdiag0 * hdiag1 - fmat->element(1,0) * fmat->element(1,0); in get_euclidean_dist()
196 …alpha = -(hinv->element(0,0) * grad[0] + hinv->element(1,0) * grad[1] + hinv->element(2,0) * grad[… in get_euclidean_dist()
197 …beta = -(hinv->element(1,0) * grad[0] + hinv->element(1,1) * grad[1] + hinv->element(2,1) * grad[… in get_euclidean_dist()
198 …gamma = -(hinv->element(2,0) * grad[0] + hinv->element(2,1) * grad[1] + hinv->element(2,2) * grad[… in get_euclidean_dist()
215 hinv->element(i,j) = fmat->element(i,0) * (*eig)[0] * fmat->element(j,0) in get_euclidean_dist()
218 …alpha = -(hinv->element(0,0) * grad[0] + hinv->element(1,0) * grad[1] + hinv->element(2,0) * grad[… in get_euclidean_dist()
219 …beta = -(hinv->element(1,0) * grad[0] + hinv->element(1,1) * grad[1] + hinv->element(2,1) * grad[… in get_euclidean_dist()
[all …]
/dports/science/qmcpack/qmcpack-3.11.0/src/QMCTools/ppconvert/src/common/
H A DCubicSplineCommon.h189 double hinv = 1.0 / h; in operator() local
190 double a = (X(hi) - x) * hinv; in operator()
191 double b = (x - X(low)) * hinv; in operator()
217 double hinv = 1.0 / h; in Deriv() local
218 double a = (X(hi) - x) * hinv; in Deriv()
219 double b = (x - X(low)) * hinv; in Deriv()
222 …return ((y(hi) - y(low)) * hinv + (h * sixinv) * ((3.0 * b * b - 1.0) * d2y(hi) - (3.0 * a * a - 1… in Deriv()
245 double hinv = 1.0 / h; in Deriv2() local
246 double a = (X(hi) - x) * hinv; in Deriv2()
247 double b = (x - X(low)) * hinv; in Deriv2()
/dports/math/R-cran-quantreg/quantreg/src/
H A Dsakj.f6 double precision con1,sum,sqsum,xsd,a,fifth,hinv,half
62 hinv=one/h
67 xponen=(x(j)-x(i))*hinv
69 xker=xker+p(i)*exp(-xponen)*hinv
75 xponen=(x(j)-x(i))*hinv
76 xker=xker+p(i)*hinv/(1+xponen**2)
92 xlam(i)=hinv/((xlam(i)*ginv)**(-alpha))
H A Dakj.f6 double precision con1,sum,sqsum,xsd,a,fifth,hinv,half
62 hinv=one/h
67 xponen=(x(j)-x(i))*hinv
69 xker=xker+p(i)*exp(-xponen)*hinv
75 xponen=(x(j)-x(i))*hinv
76 xker=xker+p(i)*hinv/(1+xponen**2)
92 xlam(i)=hinv/((xlam(i)*ginv)**(-alpha))
/dports/math/R-cran-quantreg/quantreg/src/ratfor/
H A Dsakj.r23 double precision con1,sum,sqsum,xsd,a,fifth,hinv,half,g,ginv
62 hinv=one/h globalVar
68 xponen=(x(j)-x(i))*hinv
70 xker=xker+p(i)*exp(-xponen)*hinv
75 xponen=(x(j)-x(i))*hinv
76 xker=xker+p(i)*hinv/(1+xponen**2)
88 xlam(i)=hinv/((xlam(i)*ginv)**(-alpha))
/dports/science/cp2k/cp2k-2e995eec7fd208c8a72d9544807bd8b8ba8cd1cc/src/motion/
H A Ddumpdcd.F959 SUBROUTINE invert_matrix_3x3(h, hinv, deth) argument
976 hinv(1, 1) = (h(2, 2)*h(3, 3) - h(3, 2)*h(2, 3))/deth
977 hinv(2, 1) = (h(2, 3)*h(3, 1) - h(3, 3)*h(2, 1))/deth
978 hinv(3, 1) = (h(2, 1)*h(3, 2) - h(3, 1)*h(2, 2))/deth
980 hinv(1, 2) = (h(1, 3)*h(3, 2) - h(3, 3)*h(1, 2))/deth
981 hinv(2, 2) = (h(1, 1)*h(3, 3) - h(3, 1)*h(1, 3))/deth
982 hinv(3, 2) = (h(1, 2)*h(3, 1) - h(3, 2)*h(1, 1))/deth
1066 hinv(:, :) = 0.0_dp
1067 CALL invert_matrix_3x3(h, hinv, deth)
1094 s(:, i) = r(:, i)*hinv(i, i)
[all …]
/dports/science/cp2k-data/cp2k-7.1.0/tools/
H A Ddumpdcd.f90935 SUBROUTINE invert_matrix_3x3(h,hinv,deth) argument
954 hinv(1,1) = (h(2,2)*h(3,3) - h(3,2)*h(2,3))/deth
955 hinv(2,1) = (h(2,3)*h(3,1) - h(3,3)*h(2,1))/deth
956 hinv(3,1) = (h(2,1)*h(3,2) - h(3,1)*h(2,2))/deth
958 hinv(1,2) = (h(1,3)*h(3,2) - h(3,3)*h(1,2))/deth
959 hinv(2,2) = (h(1,1)*h(3,3) - h(3,1)*h(1,3))/deth
960 hinv(3,2) = (h(1,2)*h(3,1) - h(3,2)*h(1,1))/deth
1024 hinv(:,:) = 0.0_dp
1025 CALL invert_matrix_3x3(h,hinv,deth)
1052 s(:,i) = r(:,i)*hinv(i,i)
[all …]
/dports/science/lammps/lammps-stable_29Sep2021/src/
H A Dregion_prism.cpp142 hinv[0][0] = 1.0/h[0][0]; in RegPrism()
143 hinv[0][1] = -h[0][1] / (h[0][0]*h[1][1]); in RegPrism()
144 hinv[0][2] = (h[0][1]*h[1][2] - h[0][2]*h[1][1]) / (h[0][0]*h[1][1]*h[2][2]); in RegPrism()
145 hinv[1][1] = 1.0/h[1][1]; in RegPrism()
146 hinv[1][2] = -h[1][2] / (h[1][1]*h[2][2]); in RegPrism()
147 hinv[2][2] = 1.0/h[2][2]; in RegPrism()
260 double a = hinv[0][0]*(x-xlo) + hinv[0][1]*(y-ylo) + hinv[0][2]*(z-zlo); in inside()
261 double b = hinv[1][1]*(y-ylo) + hinv[1][2]*(z-zlo); in inside()
262 double c = hinv[2][2]*(z-zlo); in inside()
/dports/science/clipper/clipper-2.1/clipper/core/
H A Dclipper_stats.cpp128 std::vector<ftype> hinv( hist.size() ); in invert() local
129 hinv[0] = range_.min(); in invert()
130 hinv[hist.size()-1] = range_.max(); in invert()
140 hinv[i] = Util::bound( range_.min(), guess, range_.max() ); in invert()
143 hist = hinv; in invert()
/dports/science/cp2k/cp2k-2e995eec7fd208c8a72d9544807bd8b8ba8cd1cc/tools/cubecruncher/
H A Dcubecruncher.f9042 REAL(KIND=dp) :: dh(3,3), h(3,3), hinv(3,3) component
231 s=MATMUL(cube%hinv,r)
256 hinv(1,1)= (h(2,2)*h(3,3)-h(3,2)*h(2,3))*uvol
257 hinv(2,1)=-(h(2,1)*h(3,3)-h(3,1)*h(2,3))*uvol
258 hinv(3,1)= (h(2,1)*h(3,2)-h(3,1)*h(2,2))*uvol
259 hinv(2,2)= (h(1,1)*h(3,3)-h(1,3)*h(3,1))*uvol
260 hinv(3,2)=-(h(1,1)*h(3,2)-h(1,2)*h(3,1))*uvol
261 hinv(3,3)= (h(1,1)*h(2,2)-h(1,2)*h(2,1))*uvol
262 hinv(1,2)=-(h(1,2)*h(3,3)-h(1,3)*h(3,2))*uvol
263 hinv(1,3)= (h(1,2)*h(2,3)-h(1,3)*h(2,2))*uvol
[all …]

1234567891011