Home
last modified time | relevance | path

Searched refs:nphi (Results 1 – 25 of 357) sorted by relevance

12345678910>>...15

/dports/science/nwchem/nwchem-7b21660b82ebd85ef659f6fba7e1e73433b0bd0a/src/nwpw/paw/paw_utils/
H A Dpaw_spher_grid.F5 subroutine get_spher_grid(ntheta,nphi,angle_phi, argument
10 integer nphi local
12 double precision angle_phi(nphi)
14 double precision w_phi(nphi)
24 if (nphi.gt.1) then
26 do i=1,nphi
27 angle_phi(i) = 2.0d0*pi*(i-1)/(nphi-1)
28 w_phi(i) = 2.0d0*pi/(nphi-1)
31 w_phi(nphi) = w_phi(1)
/dports/science/nwchem-data/nwchem-7.0.2-release/src/nwpw/paw/paw_utils/
H A Dpaw_spher_grid.F5 subroutine get_spher_grid(ntheta,nphi,angle_phi, argument
10 integer nphi
12 double precision angle_phi(nphi)
14 double precision w_phi(nphi)
24 if (nphi.gt.1) then
26 do i=1,nphi
27 angle_phi(i) = 2.0d0*pi*(i-1)/(nphi-1)
28 w_phi(i) = 2.0d0*pi/(nphi-1)
31 w_phi(nphi) = w_phi(1)
/dports/math/py-ducc0/ducc0-0.22.0/python/
H A Dsht_pymod.cc325 const py::array &nphi, in Py_synthesis() argument
362 const py::array &nphi, in Py_synthesis_deriv1() argument
596 nphi_ = nphi; in set_gauss_geometry()
611 nphi_ = nphi; in set_fejer1_geometry()
619 nphi_ = nphi; in set_fejer2_geometry()
627 nphi_ = nphi; in set_cc_geometry()
635 nphi_ = nphi; in set_dh_geometry()
643 nphi_ = nphi; in set_mw_geometry()
681 nphi(r) = nphi(rs) = size_t(ringpix); in alm2map()
720 nphi(r) = nphi(rs) = size_t(ringpix); in alm2map_adjoint()
[all …]
/dports/graphics/geomview/geomview-1.9.5/src/lib/gprim/sphere/
H A Dspheredice.c31 if (nu != sphere->ntheta || nv != sphere->nphi) { in SphereDice()
34 sphere->nphi = nv; in SphereDice()
48 int i, j, ptno, nphi, ntheta; in SphereReDice() local
50 nphi = sphere->nphi; in SphereReDice()
61 nphi = 4*sphere->nphi; phiscale = 1.0; in SphereReDice()
65 npts = nphi * ntheta; in SphereReDice()
83 for (i = 0; i < nphi; i++) { in SphereReDice()
84 phifrac = phiscale * (float)i / (float)(nphi-1); in SphereReDice()
122 CR_NU, nphi, in SphereReDice()
/dports/math/py-ducc0/ducc0-0.22.0/python/test/
H A Dtest_sht.py69 nphi=2*mmax+2
72 …l.synthesis_2d(alm=alm, lmax=lmax, mmax=mmax, spin=spin, ntheta=nrings, nphi=nphi, nthreads=nthrea…
83 job.set_cc_geometry(nrings, nphi)
85 job.set_dh_geometry(nrings, nphi)
87 job.set_fejer1_geometry(nrings, nphi)
89 job.set_fejer2_geometry(nrings, nphi)
91 job.set_mw_geometry(nrings, nphi)
93 job.set_gauss_geometry(nrings, nphi)
121 nphi=2*mmax+2
124 map0 = rng.uniform(0., 1., (alm0.shape[0], nrings, nphi))
[all …]
/dports/math/R-cran-gss/gss/R/
H A Dmkterm.R122 nphi <- 0 functionVar
138 nphi <- 1
152 nphi <- 1
154 iphi.wk <- iphi.wk + nphi
170 nphi <- 0
190 nphi <- 2
234 nphi <- par$nphi
235 if (nphi>0) {
349 rk.env <- list(dim=dm,n.phi=n.phi,nphi=nphi, globalVar
353 ind <- nu - !env$nphi
[all …]
H A Dproject.ssden1.R55 if (term$nphi>0) id.s <- c(id.s,term$iphi+(1:term$nphi)-2)
109 ns <- ns+term[[label]]$nphi
165 if (nphi>0) {
166 for (nu in 1:nphi) {
177 nphi <- par$nphi
178 if (nphi>0) {
180 for (nu in 1:nphi) {
255 nphi <- term[[label]]$nphi
257 if (nphi>0) {
258 for (nu in 1:nphi) {
[all …]
H A Dpredict.ssanova0.R24 nphi <- term[[label]]$nphi functionVar
26 if (nphi) {
29 for (i in 1:nphi) {
79 nphi <- length(philist)
81 if (nphi) pmean <- pmean + as.vector(s%*%object$d[philist])
115 if (nphi) {
118 pvar <- pvar - 2*apply(rbind(t(s),dr),2,fn2,nphi)
/dports/science/qmcpack/qmcpack-3.11.0/src/QMCWaveFunctions/HarmonicOscillator/
H A DSHOSet.cpp334 vpsi.resize(nphi); in test_derivatives()
335 vdpsi.resize(nphi); in test_derivatives()
336 vd2psi.resize(nphi); in test_derivatives()
338 vpsitmp.resize(nphi); in test_derivatives()
339 vdpsin.resize(nphi); in test_derivatives()
340 vd2psin.resize(nphi); in test_derivatives()
473 int nphi = qn_max[d]; in test_overlap() local
475 omat.resize(nphi, nphi); in test_overlap()
476 for (int i = 0; i < nphi; ++i) in test_overlap()
504 nphi = size(); in test_overlap()
[all …]
/dports/science/helfem/HelFEM-21461e9/src/general/
H A Dangular.cpp22 …void compound_rule(const arma::vec & xcth0, const arma::vec & wcth0, int nphi, arma::vec & cth, ar… in compound_rule() argument
24 cth.zeros(xcth0.n_elem*nphi); in compound_rule()
25 phi.zeros(xcth0.n_elem*nphi); in compound_rule()
26 w.zeros(xcth0.n_elem*nphi); in compound_rule()
35 double dphi=2.0*M_PI/nphi; in compound_rule()
38 for(int j=0;j<nphi;j++) { in compound_rule()
40 size_t idx=i*nphi+j; in compound_rule()
/dports/science/cp2k/cp2k-2e995eec7fd208c8a72d9544807bd8b8ba8cd1cc/src/
H A Dtopology_psf.F306 nphi = 0
308 CALL parser_get_object(parser, nphi)
317 DO iphi = 1, nphi, 2
327 DO iphi = 1, nphi, 2
355 nphi = 0
357 CALL parser_get_object(parser, nphi)
366 DO iphi = 1, nphi, 2
376 DO iphi = 1, nphi, 2
481 nphi = 0
504 DO ionfo = 1, nphi
[all …]
/dports/science/cp2k-data/cp2k-7.1.0/src/
H A Dtopology_psf.F306 nphi = 0
308 CALL parser_get_object(parser, nphi)
317 DO iphi = 1, nphi, 2
327 DO iphi = 1, nphi, 2
355 nphi = 0
357 CALL parser_get_object(parser, nphi)
366 DO iphi = 1, nphi, 2
376 DO iphi = 1, nphi, 2
481 nphi = 0
504 DO ionfo = 1, nphi
[all …]
/dports/science/mcstas-comps/mcstas-comps-2.5-src/monitors/
H A DTOF_cylPSD_monitor.comp28 * nphi: [deg] Number of angular bins
43 DEFINITION PARAMETERS (nt=128, nphi=90)
49 double TOF_N[nt][nphi];
50 double TOF_p[nt][nphi];
51 double TOF_p2[nt][nphi];
61 for (j=0; j<nphi; j++)
67 binphi=360.0/(double)nphi;
93 j = floor((double)nphi/2.0 + RAD2DEG*phi/(double)binphi);
110 nt, nphi,
/dports/math/libpgmath/flang-d07daf3/test/f90_correct/src/
H A Dfe65.f9017 subroutine x(nphi) argument
18 integer :: nphi local
24 within(1:nphi) = rmod .lt. rmax(1:nphi) !! LEGAL
/dports/science/healpix/Healpix_3.50/src/cxx/libsharp/
H A Dsharp_geomhelpers.h75 void sharp_make_gauss_geom_info (int nrings, int nphi, double phi0,
91 void sharp_make_fejer1_geom_info (int nrings, int nphi, double phi0,
96 static inline void sharp_make_ecp_geom_info (int nrings, int nphi, double phi0, in sharp_make_ecp_geom_info() argument
99 sharp_make_fejer1_geom_info (nrings, nphi, phi0, stride_lon, stride_lat, in sharp_make_ecp_geom_info()
/dports/math/libsharp2/libsharp-54856313a5fcfb6a33817b7dfa28c4b1965ffbd1/libsharp2/
H A Dsharp_geomhelpers.h71 void sharp_make_gauss_geom_info (int nrings, int nphi, double phi0,
87 void sharp_make_fejer1_geom_info (int nrings, int nphi, double phi0,
92 static inline void sharp_make_ecp_geom_info (int nrings, int nphi, double phi0, in sharp_make_ecp_geom_info() argument
95 sharp_make_fejer1_geom_info (nrings, nphi, phi0, stride_lon, stride_lat, in sharp_make_ecp_geom_info()
/dports/astro/gpsbabel14/gpsbabel-1.4.4/jeeps/
H A Dgpsmath.c368 double nphi; in GPS_Math_XYZ_To_LatLonH() local
386 nphi = phix; in GPS_Math_XYZ_To_LatLonH()
1176 double nphi=0.0; in GPS_Math_EN_To_LatLon() local
1203 nphi = phix; in GPS_Math_EN_To_LatLon()
1209 tmp2 *= (sin(nphi-phi0) * cos(nphi+phi0)); in GPS_Math_EN_To_LatLon()
1232 tmp = (double)5.0 + (double)3.0 * tan(nphi) * tan(nphi) + etasq; in GPS_Math_EN_To_LatLon()
1233 tmp -= (double)9.0 * tan(nphi) * tan(nphi) * etasq; in GPS_Math_EN_To_LatLon()
1236 tmp = (double)61.0 + (double)90.0 * tan(nphi) * tan(nphi); in GPS_Math_EN_To_LatLon()
1242 tmp = (nu / rho) + (double)2.0 * tan(nphi) * tan(nphi); in GPS_Math_EN_To_LatLon()
1245 tmp = (double)5.0 + (double)28.0 * tan(nphi)*tan(nphi); in GPS_Math_EN_To_LatLon()
[all …]
/dports/astro/opencpn/OpenCPN-5.2.4/libs/garmin/jeeps/
H A Dgpsmath.c369 double nphi; in GPS_Math_XYZ_To_LatLonH() local
384 nphi = phix; in GPS_Math_XYZ_To_LatLonH()
385 nu = a / pow(((double)1.0-esq*sin(nphi)*sin(nphi)),(double)0.5); in GPS_Math_XYZ_To_LatLonH()
1193 nphi = phix; in GPS_Math_EN_To_LatLon()
1199 tmp2 *= (sin(nphi-phi0) * cos(nphi+phi0)); in GPS_Math_EN_To_LatLon()
1221 tmp = (double)5.0 + (double)3.0 * tan(nphi) * tan(nphi) + etasq; in GPS_Math_EN_To_LatLon()
1222 tmp -= (double)9.0 * tan(nphi) * tan(nphi) * etasq; in GPS_Math_EN_To_LatLon()
1225 tmp = (double)61.0 + (double)90.0 * tan(nphi) * tan(nphi); in GPS_Math_EN_To_LatLon()
1231 tmp = (nu / rho) + (double)2.0 * tan(nphi) * tan(nphi); in GPS_Math_EN_To_LatLon()
1234 tmp = (double)5.0 + (double)28.0 * tan(nphi)*tan(nphi); in GPS_Math_EN_To_LatLon()
[all …]
/dports/astro/gpsbabel/gpsbabel-gpsbabel_1_7_0/jeeps/
H A Dgpsmath.cc368 double nphi; in GPS_Math_XYZ_To_LatLonH() local
383 nphi = 1e20; in GPS_Math_XYZ_To_LatLonH()
386 nphi = phix; in GPS_Math_XYZ_To_LatLonH()
387 nu = a / pow((1.0-esq*sin(nphi)*sin(nphi)),0.5); in GPS_Math_XYZ_To_LatLonH()
1218 tmp2 *= (sin(nphi-phi0) * cos(nphi+phi0)); in GPS_Math_EN_To_LatLon()
1241 tmp = 5.0 + 3.0 * tan(nphi) * tan(nphi) + etasq; in GPS_Math_EN_To_LatLon()
1242 tmp -= 9.0 * tan(nphi) * tan(nphi) * etasq; in GPS_Math_EN_To_LatLon()
1245 tmp = 61.0 + 90.0 * tan(nphi) * tan(nphi); in GPS_Math_EN_To_LatLon()
1251 tmp = (nu / rho) + 2.0 * tan(nphi) * tan(nphi); in GPS_Math_EN_To_LatLon()
1254 tmp = 5.0 + 28.0 * tan(nphi)*tan(nphi); in GPS_Math_EN_To_LatLon()
[all …]
/dports/lang/luajit/LuaJIT-2.0.5/src/
H A Dlj_opt_loop.c111 for (i = 0, j = 0; i < nphi; i++) { in loop_emit_phi()
125 nphi = j; in loop_emit_phi()
166 if (nphi >= LJ_MAX_PHI) in loop_emit_phi()
168 phi[nphi++] = (IRRef1)ref; in loop_emit_phi()
177 for (i = 0; i < nphi; i++) { in loop_emit_phi()
190 for (i = 0; i < nphi; i++) { in loop_emit_phi()
261 uint32_t nphi = 0; in loop_unroll() local
329 if (nphi >= LJ_MAX_PHI) in loop_unroll()
331 phi[nphi++] = (IRRef1)ref; in loop_unroll()
356 if (nphi >= LJ_MAX_PHI) in loop_unroll()
[all …]
/dports/lang/luajit-devel/LuaJIT-a91d0d9/src/
H A Dlj_opt_loop.c111 for (i = 0, j = 0; i < nphi; i++) { in loop_emit_phi()
125 nphi = j; in loop_emit_phi()
166 if (nphi >= LJ_MAX_PHI) in loop_emit_phi()
168 phi[nphi++] = (IRRef1)ref; in loop_emit_phi()
177 for (i = 0; i < nphi; i++) { in loop_emit_phi()
190 for (i = 0; i < nphi; i++) { in loop_emit_phi()
269 uint32_t nphi = 0; in loop_unroll() local
338 if (nphi >= LJ_MAX_PHI) in loop_unroll()
340 phi[nphi++] = (IRRef1)ref; in loop_unroll()
367 if (nphi >= LJ_MAX_PHI) in loop_unroll()
[all …]
/dports/lang/luajit-openresty/luajit2-2.1-20211210/src/
H A Dlj_opt_loop.c111 for (i = 0, j = 0; i < nphi; i++) { in loop_emit_phi()
125 nphi = j; in loop_emit_phi()
166 if (nphi >= LJ_MAX_PHI) in loop_emit_phi()
168 phi[nphi++] = (IRRef1)ref; in loop_emit_phi()
177 for (i = 0; i < nphi; i++) { in loop_emit_phi()
190 for (i = 0; i < nphi; i++) { in loop_emit_phi()
269 uint32_t nphi = 0; in loop_unroll() local
338 if (nphi >= LJ_MAX_PHI) in loop_unroll()
340 phi[nphi++] = (IRRef1)ref; in loop_unroll()
367 if (nphi >= LJ_MAX_PHI) in loop_unroll()
[all …]
/dports/graphics/urho3d/Urho3D-1.7.1/Source/ThirdParty/LuaJIT/src/
H A Dlj_opt_loop.c111 for (i = 0, j = 0; i < nphi; i++) { in loop_emit_phi()
125 nphi = j; in loop_emit_phi()
166 if (nphi >= LJ_MAX_PHI) in loop_emit_phi()
168 phi[nphi++] = (IRRef1)ref; in loop_emit_phi()
177 for (i = 0; i < nphi; i++) { in loop_emit_phi()
190 for (i = 0; i < nphi; i++) { in loop_emit_phi()
268 uint32_t nphi = 0; in loop_unroll() local
336 if (nphi >= LJ_MAX_PHI) in loop_unroll()
338 phi[nphi++] = (IRRef1)ref; in loop_unroll()
363 if (nphi >= LJ_MAX_PHI) in loop_unroll()
[all …]
/dports/devel/tex-libtexluajit/texlive-20150521-source/libs/luajit/LuaJIT-2.0.3/src/
H A Dlj_opt_loop.c111 for (i = 0, j = 0; i < nphi; i++) { in loop_emit_phi()
125 nphi = j; in loop_emit_phi()
166 if (nphi >= LJ_MAX_PHI) in loop_emit_phi()
168 phi[nphi++] = (IRRef1)ref; in loop_emit_phi()
177 for (i = 0; i < nphi; i++) { in loop_emit_phi()
190 for (i = 0; i < nphi; i++) { in loop_emit_phi()
261 uint32_t nphi = 0; in loop_unroll() local
329 if (nphi >= LJ_MAX_PHI) in loop_unroll()
331 phi[nphi++] = (IRRef1)ref; in loop_unroll()
356 if (nphi >= LJ_MAX_PHI) in loop_unroll()
[all …]
/dports/misc/xplr/xplr-0.17.0/cargo-crates/luajit-src-210.3.2+resty1085a4d/luajit2/src/
H A Dlj_opt_loop.c111 for (i = 0, j = 0; i < nphi; i++) { in loop_emit_phi()
125 nphi = j; in loop_emit_phi()
166 if (nphi >= LJ_MAX_PHI) in loop_emit_phi()
168 phi[nphi++] = (IRRef1)ref; in loop_emit_phi()
177 for (i = 0; i < nphi; i++) { in loop_emit_phi()
190 for (i = 0; i < nphi; i++) { in loop_emit_phi()
269 uint32_t nphi = 0; in loop_unroll() local
338 if (nphi >= LJ_MAX_PHI) in loop_unroll()
340 phi[nphi++] = (IRRef1)ref; in loop_unroll()
367 if (nphi >= LJ_MAX_PHI) in loop_unroll()
[all …]

12345678910>>...15