Home
last modified time | relevance | path

Searched refs:iphi (Results 1 – 25 of 186) sorted by relevance

12345678

/dports/astro/oskar/OSKAR-2.8.0/oskar/convert/src/
H A Doskar_convert_healpix_ring_to_theta_phi.c74 int iring = 0, iphi = 0, ip = 0; in oskar_convert_healpix_ring_to_theta_phi_d() local
89 iphi = (ipix + 1) - 2 * iring * (iring - 1); in oskar_convert_healpix_ring_to_theta_phi_d()
92 *phi = (iphi - 0.5) * M_PI / (2.0 * iring); in oskar_convert_healpix_ring_to_theta_phi_d()
100 iphi = ip % (4 * nside) + 1; in oskar_convert_healpix_ring_to_theta_phi_d()
105 *phi = (iphi - fodd) * M_PI / (2.0 * nside); in oskar_convert_healpix_ring_to_theta_phi_d()
118 *phi = (iphi - 0.5) * M_PI / (2.0 * iring); in oskar_convert_healpix_ring_to_theta_phi_d()
125 int iring = 0, iphi = 0, ip = 0; in oskar_convert_healpix_ring_to_theta_phi_f() local
140 iphi = (ipix + 1) - 2 * iring * (iring - 1); in oskar_convert_healpix_ring_to_theta_phi_f()
143 *phi = (iphi - 0.5) * M_PI / (2.0 * iring); in oskar_convert_healpix_ring_to_theta_phi_f()
151 iphi = ip % (4 * nside) + 1; in oskar_convert_healpix_ring_to_theta_phi_f()
[all …]
/dports/science/nwchem-data/nwchem-7.0.2-release/src/ddscf/
H A Dga_mat_to_vec.F31 integer iplo, iphi, jplo, jphi, k_m ! local patch of m
49 call ga_distribution(g_m, ga_nodeid(), iplo, iphi, jplo, jphi)
52 if (iplo.gt.0 .and. iplo.le.iphi) then
53 numi = min(ihi,iphi) - max(ilo,iplo) + 1
56 call ga_access(g_m,iplo,iphi,jplo,jphi,k_m,ld)
70 call ga_release(g_m,iplo,iphi,jplo,jphi)
95 integer iplo, iphi, jplo, jphi, k_m ! local patch of m
106 if (iplo.gt.0 .and. iplo.le.iphi) then
107 numi = min(ihi,iphi) - max(ilo,iplo) + 1
110 call ga_access(g_m,iplo,iphi,jplo,jphi,k_m,ld)
[all …]
/dports/science/nwchem/nwchem-7b21660b82ebd85ef659f6fba7e1e73433b0bd0a/src/ddscf/
H A Dga_mat_to_vec.F31 integer iplo, iphi, jplo, jphi, k_m ! local patch of m
49 call ga_distribution(g_m, ga_nodeid(), iplo, iphi, jplo, jphi)
52 if (iplo.gt.0 .and. iplo.le.iphi) then
53 numi = min(ihi,iphi) - max(ilo,iplo) + 1
56 call ga_access(g_m,iplo,iphi,jplo,jphi,k_m,ld)
70 call ga_release(g_m,iplo,iphi,jplo,jphi)
95 integer iplo, iphi, jplo, jphi, k_m ! local patch of m
106 if (iplo.gt.0 .and. iplo.le.iphi) then
107 numi = min(ihi,iphi) - max(ilo,iplo) + 1
110 call ga_access(g_m,iplo,iphi,jplo,jphi,k_m,ld)
[all …]
/dports/sysutils/ipdbtools/ipdb-1.1.2/
H A Dipdb.c105 uint32_t iplo, iphi; in readRIRStatisticsFormat_v2() local
117 iphi = iplo + (uint32_t)strtoul(ct, NULL, 10) - 1; in readRIRStatisticsFormat_v2()
119 while (node = findNet4Node(iplo, iphi, *(uint16_t*)cc, IP4Store)) in readRIRStatisticsFormat_v2()
124 if (node->hi > iphi) in readRIRStatisticsFormat_v2()
125 iphi = node->hi; in readRIRStatisticsFormat_v2()
130 addIP4Node(iplo, iphi, *(uint16_t*)cc, &IP4Store); count++; in readRIRStatisticsFormat_v2()
138 uint128t iplo, iphi; in readRIRStatisticsFormat_v2() local
152 while (node = findNet6Node(iplo, iphi, *(uint16_t*)cc, IP6Store)) in readRIRStatisticsFormat_v2()
157 if (gt_u128(node->hi, iphi)) in readRIRStatisticsFormat_v2()
158 iphi = node->hi; in readRIRStatisticsFormat_v2()
[all …]
/dports/astro/wcslib/wcslib-7.7/C/
H A Dprj.c819 for (iphi = 0; iphi < mphi; iphi++, xp += sxy, yp += sxy) { in azps2x()
1160 for (iphi = 0; iphi < mphi; iphi++, xp += sxy, yp += sxy) { in szps2x()
1173 for (iphi = 0; iphi < mphi; iphi++, xp += sxy, yp += sxy) { in szps2x()
1411 for (iphi = 0; iphi < mphi; iphi++, xp += sxy, yp += sxy) { in tans2x()
2208 for (iphi = 0; iphi < mphi; iphi++, xp += sxy, yp += sxy) { in arcs2x()
2612 for (iphi = 0; iphi < mphi; iphi++, xp += sxy, yp += sxy) { in zpns2x()
2839 for (iphi = 0; iphi < mphi; iphi++, xp += sxy, yp += sxy) { in zeas2x()
3399 for (iphi = 0; iphi < mphi; iphi++, yp += sxy) { in cyps2x()
3628 for (iphi = 0; iphi < mphi; iphi++, yp += sxy) { in ceas2x()
3825 for (iphi = 0; iphi < mphi; iphi++, yp += sxy) { in cars2x()
[all …]
H A Dsph.c50 register int iphi, itheta; in sphx2s() local
76 for (iphi = 0; iphi < mphi; iphi++, phip += spt, jphi++) { in sphx2s()
108 for (iphi = 0; iphi < mphi; iphi++, phip += spt, jphi++) { in sphx2s()
139 for (iphi = 0; iphi < nphi; iphi++, rowoff += sll, phip += spt) { in sphx2s()
161 for (iphi = 0; iphi < mphi; iphi++, lngp += sll, latp += sll) { in sphx2s()
/dports/astro/py-astropy/astropy-5.0/cextern/wcslib/C/
H A Dprj.c819 for (iphi = 0; iphi < mphi; iphi++, xp += sxy, yp += sxy) { in azps2x()
1160 for (iphi = 0; iphi < mphi; iphi++, xp += sxy, yp += sxy) { in szps2x()
1173 for (iphi = 0; iphi < mphi; iphi++, xp += sxy, yp += sxy) { in szps2x()
1411 for (iphi = 0; iphi < mphi; iphi++, xp += sxy, yp += sxy) { in tans2x()
2208 for (iphi = 0; iphi < mphi; iphi++, xp += sxy, yp += sxy) { in arcs2x()
2612 for (iphi = 0; iphi < mphi; iphi++, xp += sxy, yp += sxy) { in zpns2x()
2839 for (iphi = 0; iphi < mphi; iphi++, xp += sxy, yp += sxy) { in zeas2x()
3399 for (iphi = 0; iphi < mphi; iphi++, yp += sxy) { in cyps2x()
3628 for (iphi = 0; iphi < mphi; iphi++, yp += sxy) { in ceas2x()
3825 for (iphi = 0; iphi < mphi; iphi++, yp += sxy) { in cars2x()
[all …]
H A Dsph.c50 register int iphi, itheta; in sphx2s() local
76 for (iphi = 0; iphi < mphi; iphi++, phip += spt, jphi++) { in sphx2s()
108 for (iphi = 0; iphi < mphi; iphi++, phip += spt, jphi++) { in sphx2s()
139 for (iphi = 0; iphi < nphi; iphi++, rowoff += sll, phip += spt) { in sphx2s()
161 for (iphi = 0; iphi < mphi; iphi++, lngp += sll, latp += sll) { in sphx2s()
/dports/astro/siril/siril/subprojects/wcslib/
H A Dprj.c794 for (iphi = 0; iphi < mphi; iphi++, xp += sxy, yp += sxy) { in azps2x()
1135 for (iphi = 0; iphi < mphi; iphi++, xp += sxy, yp += sxy) { in szps2x()
1148 for (iphi = 0; iphi < mphi; iphi++, xp += sxy, yp += sxy) { in szps2x()
1386 for (iphi = 0; iphi < mphi; iphi++, xp += sxy, yp += sxy) { in tans2x()
2183 for (iphi = 0; iphi < mphi; iphi++, xp += sxy, yp += sxy) { in arcs2x()
2587 for (iphi = 0; iphi < mphi; iphi++, xp += sxy, yp += sxy) { in zpns2x()
2814 for (iphi = 0; iphi < mphi; iphi++, xp += sxy, yp += sxy) { in zeas2x()
3374 for (iphi = 0; iphi < mphi; iphi++, yp += sxy) { in cyps2x()
3603 for (iphi = 0; iphi < mphi; iphi++, yp += sxy) { in ceas2x()
3800 for (iphi = 0; iphi < mphi; iphi++, yp += sxy) { in cars2x()
[all …]
H A Dsph.c52 register int iphi, itheta; in sphx2s() local
78 for (iphi = 0; iphi < mphi; iphi++, phip += spt, jphi++) { in sphx2s()
110 for (iphi = 0; iphi < mphi; iphi++, phip += spt, jphi++) { in sphx2s()
141 for (iphi = 0; iphi < nphi; iphi++, rowoff += sll, phip += spt) { in sphx2s()
163 for (iphi = 0; iphi < mphi; iphi++, lngp += sll, latp += sll) { in sphx2s()
/dports/science/fastjet/fastjet-3.3.4/src/
H A DRectangularGrid.cc72 int iphi = int( p.phi() * _inverse_dphi ); in tile_index() local
73 if (iphi == _nphi) iphi = 0; // just in case of rounding errors in tile_index()
75 return iy*_nphi + iphi; in tile_index()
108 int iphi = i % _nphi; in _setup_grid() local
110 double phi = (iphi + 0.5)*_dphi; in _setup_grid()
H A DLazyTiling9Alt.cc121 for (int iphi = 0; iphi < _n_tiles_phi; iphi++) { in _initialise_tiles() local
122 Tile * tile = & _tiles[_tile_index(ieta,iphi)]; in _initialise_tiles()
142 *pptile = Tile::TileFnPair(& _tiles[_tile_index(ieta-1,iphi)], in _initialise_tiles()
150 *pptile = Tile::TileFnPair(& _tiles[_tile_index(ieta,iphi-1)], in _initialise_tiles()
155 *pptile = Tile::TileFnPair(& _tiles[_tile_index(ieta,iphi+1)], in _initialise_tiles()
179 tile->use_periodic_delta_phi = use_periodic_delta_phi[iphi]; in _initialise_tiles()
185 tile->phi_min = iphi*_tile_size_phi; in _initialise_tiles()
186 tile->phi_max = (iphi+1)*_tile_size_phi; in _initialise_tiles()
195 int ieta, iphi; in _tile_index() local
209 iphi = int((phi+twopi)/_tile_size_phi) % _n_tiles_phi; in _tile_index()
[all …]
H A DLazyTiling25.cc166 for (int iphi = 0; iphi < _n_tiles_phi; iphi++) { in _initialise_tiles() local
181 *pptile = & _tiles[_tile_index(ieta-1,iphi+idphi)]; in _initialise_tiles()
191 *pptile = & _tiles[_tile_index(ieta-2,iphi+idphi)]; in _initialise_tiles()
196 *pptile = & _tiles[_tile_index(ieta,iphi-1)]; in _initialise_tiles()
198 *pptile = & _tiles[_tile_index(ieta,iphi-2)]; in _initialise_tiles()
202 *pptile = & _tiles[_tile_index(ieta,iphi+1)]; in _initialise_tiles()
204 *pptile = & _tiles[_tile_index(ieta,iphi+2)]; in _initialise_tiles()
209 *pptile = & _tiles[_tile_index(ieta+1,iphi+idphi)]; in _initialise_tiles()
230 tile->phi_centre = (iphi+0.5)*_tile_size_phi; in _initialise_tiles()
239 int ieta, iphi; in _tile_index() local
[all …]
/dports/science/healpix/Healpix_3.50/src/idl/toolkit/
H A Dpix2vec_ring.pro133 iphi = ip - 2L*iring*(iring-one)
135 phi = (iphi - 0.5d0) * !DPI/(2.d0*iring)
147 iphi_mod = (iphi-1) MOD iring ; in {0,1,... iring-1}
148 iphi_rat = (iphi-1) / iring ; in {0,1,2,3}
171 iphi = ( ip MOD nl4 ) + one
175 phi = (iphi - fodd) * !DPI/(2.d0*nl1)
193 iphi_rat = (iphi[k1]-1) / nl1 ; in {0,1,2,3}
199 iphi_rat = (iphi[k3]-1) / nl1 ; in {0,1,2,3}
222 phi = (iphi - 0.5d0) * !DPI/(2.d0*iring)
234 iphi_mod = (iphi-1) MOD iring ; in {0,1,... iring-1}
[all …]
H A Dpix2ang_ring.pro122 iphi = ip - 2L*iring*(iring-one)
125 phi[pix_np] = (iphi - 0.5d0) * !DPI/(2.d0*iring)
126 ip = 0 & iring =0 & iphi = 0 ; free memory
136 iphi = ( ip MOD nl4 ) + one
141 phi[pix_eq] = (iphi - fodd) * !DPI/(2.d0*nl1)
142 ;;print, ip, iring, iphi, fodd
143 ip = 0 & iring =0 & iphi = 0 & fodd = 0; free memory
154 iphi = one - ip + 2L*iring*(iring+one) ; in [1, 4*iring]
157 phi[pix_sp] = (iphi - 0.5d0) * !DPI/(2.d0*iring)
158 ip = 0 & iring =0 & iphi = 0 ; free memory
H A Dring2nest.pro101 iphi = LON64ARR(np, /NoZero)
112 iphi = LONARR(np, /NoZero)
133 iphi[pix_npl] = ip - 2L*irn*(irn-one)
136 face_num[pix_npl] = (iphi[pix_npl]-1) / irn ; in {0,3}
148 iphi[pix_eqt] = ( ip MOD nl4 ) + 1
155 ifm = (iphi[pix_eqt] - ire/2 + nl1 -1) / nl1 ; face boundary
156 ifp = (iphi[pix_eqt] - irm/2 + nl1 -1) / nl1
179 ;; iphi[pix_spl] = 4*irs + one - (ip - 2L*irs*(irs-one))
180 iphi[pix_spl] = one - ip + 2L*irs*(irs+one)
183 face_num[pix_spl] = (iphi[pix_spl]-1) / irs + 8 ; in {8,11}
[all …]
/dports/science/lammps/lammps-stable_29Sep2021/src/EXTRA-COMPUTE/
H A Dcompute_pressure_cylinder.cpp154 for (int iphi = 0; iphi < nphi; iphi++) { in init() local
155 phi=((double)iphi)*MY_PI/180.0; in init()
156 tangent[iphi]=tan(phi); in init()
157 ephi_x[iphi]=-sin(phi); in init()
158 ephi_y[iphi]=cos(phi); in init()
399 for (int iphi = 0; iphi < nphi; iphi++) { in compute_array() local
400 alpha=(yi-xi*tangent[iphi])/(dx*tangent[iphi]-dy); in compute_array()
417 ftphi=fabs(dx*ephi_x[iphi]+dy*ephi_y[iphi])*fpair; in compute_array()
/dports/science/gromacs/gromacs-2021.4/src/gromacs/gmxana/
H A Dpp2shift.cpp62 int iphi, ipsi, iphi1, ipsi1; in interpolate() local
83 iphi = static_cast<int>(fphi); in interpolate()
85 fphi -= iphi; /* Fraction (offset from gridpoint) */ in interpolate()
92 iphi = iphi % sd->nx; in interpolate()
94 iphi1 = (iphi + 1) % sd->nx; in interpolate()
97 return (sd->data[iphi][ipsi] * wx0 * wy0 + sd->data[iphi1][ipsi] * wx1 * wy0 in interpolate()
98 + sd->data[iphi][ipsi1] * wx0 * wy1 + sd->data[iphi1][ipsi1] * wx1 * wy1); in interpolate()
/dports/science/healpix/Healpix_3.50/src/C/subs/
H A Dchealpix.c187 int iring, iphi, kshift, nr; in ring2xyf() local
198 *face_num = special_div(iphi-1,nr); in ring2xyf()
204 iphi = (ip%(4*nside_)) + 1; in ring2xyf()
331 *phi = (iphi-0.5) * halfpi/iring; in pix2ang_ring_z_phi()
338 int iphi = ip%(4*nside_) + 1; in pix2ang_ring_z_phi() local
344 *phi = (iphi-fodd) * pi/nl2; in pix2ang_ring_z_phi()
353 *phi = (iphi-0.5) * halfpi/iring; in pix2ang_ring_z_phi()
594 int64_t iring, iphi, kshift, nr; in ring2xyf64() local
611 iphi = (ip%(4*nside_)) + 1; in ring2xyf64()
747 *phi = (iphi-0.5) * halfpi/iring; in pix2ang_ring_z_phi64()
[all …]
/dports/science/healpix/Healpix_3.50/src/C/autotools/
H A Dchealpix.c187 int iring, iphi, kshift, nr; in ring2xyf() local
198 *face_num = special_div(iphi-1,nr); in ring2xyf()
204 iphi = (ip%(4*nside_)) + 1; in ring2xyf()
331 *phi = (iphi-0.5) * halfpi/iring; in pix2ang_ring_z_phi()
338 int iphi = ip%(4*nside_) + 1; in pix2ang_ring_z_phi() local
344 *phi = (iphi-fodd) * pi/nl2; in pix2ang_ring_z_phi()
353 *phi = (iphi-0.5) * halfpi/iring; in pix2ang_ring_z_phi()
594 int64_t iring, iphi, kshift, nr; in ring2xyf64() local
611 iphi = (ip%(4*nside_)) + 1; in ring2xyf64()
747 *phi = (iphi-0.5) * halfpi/iring; in pix2ang_ring_z_phi64()
[all …]
/dports/science/fastjet/fastjet-3.3.4/plugins/GridJet/
H A DGridJetPlugin.cc103 int iphi = int( p.phi()/_dphi ); in tile_index() local
104 assert(iphi >= 0 && iphi <= _nphi); in tile_index()
105 if (iphi == _nphi) iphi = 0; // just in case of rounding errors in tile_index()
107 int igrid_res = iy*_nphi + iphi; in tile_index()
/dports/science/fastjet/fastjet-3.3.4/tools/
H A DGridMedianBackgroundEstimator.cc310 int iphi = int( p.phi()/_dphi ); in tile_index() local
311 assert(iphi >= 0 && iphi <= _nphi); in tile_index()
312 if (iphi == _nphi) iphi = 0; // just in case of rounding errors in tile_index()
314 int index_res = iy*_nphi + iphi; in tile_index()
/dports/science/cp2k/cp2k-2e995eec7fd208c8a72d9544807bd8b8ba8cd1cc/src/
H A Dtopology_amber.F1601 iphi = iphi + 1
1603 IF (iphi > SIZE(label_a)) THEN
1612 label_a(iphi) = work_label(1, 1)
1613 label_b(iphi) = work_label(2, 1)
1614 label_c(iphi) = work_label(3, 1)
1615 label_d(iphi) = work_label(4, 1)
1616 k(iphi) = pk(icp(iwork(1)))*0.5_dp
1617 m(iphi) = NINT(pn(icp(iwork(1))))
1623 phi0(iphi) = phase(icp(iwork(1)))
1635 iphi = iphi + 1
[all …]
/dports/science/cp2k-data/cp2k-7.1.0/src/
H A Dtopology_amber.F1601 iphi = iphi + 1
1603 IF (iphi > SIZE(label_a)) THEN
1612 label_a(iphi) = work_label(1, 1)
1613 label_b(iphi) = work_label(2, 1)
1614 label_c(iphi) = work_label(3, 1)
1615 label_d(iphi) = work_label(4, 1)
1616 k(iphi) = pk(icp(iwork(1)))*0.5_dp
1617 m(iphi) = NINT(pn(icp(iwork(1))))
1623 phi0(iphi) = phase(icp(iwork(1)))
1635 iphi = iphi + 1
[all …]
/dports/science/fastjet/fastjet-3.3.4/include/fastjet/
H A DNNFJN2Tiled.hh162 inline int _tile_index (int irap, int iphi) const { in _tile_index()
166 + (iphi+_n_tiles_phi) % _n_tiles_phi; in _tile_index()
549 for (int iphi = 0; iphi < _n_tiles_phi; iphi++) { in _initialise_tiles() local
550 Tile * tile = & _tiles[_tile_index(irap,iphi)]; in _initialise_tiles()
564 *pptile = & _tiles[_tile_index(irap-1,iphi+idphi)]; in _initialise_tiles()
569 *pptile = & _tiles[_tile_index(irap,iphi-1)]; in _initialise_tiles()
573 *pptile = & _tiles[_tile_index(irap,iphi+1)]; in _initialise_tiles()
578 *pptile = & _tiles[_tile_index(irap+1,iphi+idphi)]; in _initialise_tiles()
595 int irap, iphi; in _tile_index() local
609 iphi = int((phi+twopi)/_tile_size_phi) % _n_tiles_phi; in _tile_index()
[all …]

12345678