Home
last modified time | relevance | path

Searched refs:nlev (Results 1 – 25 of 440) sorted by relevance

12345678910>>...18

/dports/science/cdo/cdo-2.0.0/src/
H A Dspecspace.cc19 const long nlev = 1; in grid2spec() local
26 std::vector<double> fpwork(nlat * nfc * nlev); in grid2spec()
40 const long nlev = 1; in spec2grid() local
47 std::vector<double> fpwork(nlat * nfc * nlev); in spec2grid()
61 const long nlev = 1; in four2spec() local
73 const long nlev = 1; in spec2four() local
86 const long nlev = 1; in four2grid() local
102 const long nlev = 1; in grid2four() local
148 std::vector<double> fpwork1(nlat * nfc * nlev); in trans_uv2dv()
149 std::vector<double> fpwork2(nlat * nfc * nlev); in trans_uv2dv()
[all …]
H A Dexpr.cc369 out.nlev = in.nlev; in param_meta_copy()
499 const auto nlev = (p2->param.nlev > 0) ? p2->param.nlev : 1; in expr_con_var() local
534 const auto nlev = (p1->param.nlev > 0) ? p1->param.nlev : 1; in expr_var_con() local
732 auto nlev = p2->param.nlev; in ex_copy_con() local
921 const auto nlev = (p1->param.nlev > 0) ? p1->param.nlev : 1; in ex_fun_var() local
1107 const auto nlev = (p1->param.nlev > 0) ? p1->param.nlev : 1; in fun1c() local
1196 const auto nlev = (p1->param.nlev > 0) ? p1->param.nlev : 1; in fun2c() local
1337 const auto nlev = (p1->param.nlev > 0) ? p1->param.nlev : 1; in ex_uminus_var() local
1410 const auto nlev = (p1->param.nlev > 0) ? p1->param.nlev : 1; in ex_not_var() local
1515 auto nlev = (p0->param.nlev > 0) ? p0->param.nlev : 1; in ex_ifelse() local
[all …]
H A Dexpr_fun.cc46 vert_weights(int zaxisID, size_t nlev, Varray<double> &weights) in vert_weights() argument
48 weights.resize(nlev); in vert_weights()
49 std::vector<double> thickness(nlev); in vert_weights()
50 for (size_t i = 0; i < nlev; ++i) weights[i] = 1; in vert_weights()
52 if (nlev > 1) in vert_weights()
55 int wstatus = get_layer_thickness(1, 0, 0, zaxisID, nlev, thickness.data(), weights.data()); in vert_weights()
56 if (wstatus == 0 && lwarn && nlev > 1) in vert_weights()
H A DInvertlev.cc29 const auto nlev = zaxisInqSize(zaxisID1); in invertLevDes() local
30 if (nlev <= 1) continue; in invertLevDes()
34 Varray<double> yv1(nlev), yv2(nlev); in invertLevDes()
36 for (int ilev = 0; ilev < nlev; ++ilev) yv2[nlev - ilev - 1] = yv1[ilev]; in invertLevDes()
42 Varray<double> yb1(nlev), yb2(nlev); in invertLevDes()
44 for (int ilev = 0; ilev < nlev; ++ilev) yb2[nlev - ilev - 1] = yb1[ilev]; in invertLevDes()
48 for (int ilev = 0; ilev < nlev; ++ilev) yb2[nlev - ilev - 1] = yb1[ilev]; in invertLevDes()
H A DWind.cc72 size_t nlev = 0; in Wind() local
207 nlev = zaxisInqSize(vlistInqVarZaxis(vlistID1, varID1)); in Wind()
209 spTrans.init(nlon, nlat, ntr, PolFlag::UV2DV, nlev); in Wind()
249 spTrans.init(nlon, nlat, ntr, PolFlag::SP2FC, nlev); in Wind()
283 nlev = zaxisInqSize(vlistInqVarZaxis(vlistID1, varID1)); in Wind()
286 ivar1.resize(nlev * gridsize); in Wind()
287 ivar2.resize(nlev * gridsize); in Wind()
290 ovar1.resize(nlev * gridsize); in Wind()
291 ovar2.resize(nlev * gridsize); in Wind()
344 dv2ps(ivar1.data(), ovar1.data(), nlev, ntr); in Wind()
[all …]
H A DMastrfu.cc27 const auto nlev = zaxisInqSize(zaxisID); in mastrfu() local
28 Varray<double> phi(nlat), cosphi(nlat), plevel(nlev); in mastrfu()
45 for (int ilev = 0; ilev < nlev; ilev++) in mastrfu()
50 for (int ilev = nlev - 1; ilev >= 0; ilev--) in mastrfu()
51 for (int n = ilev; n < nlev - 1; n++) in mastrfu()
60 for (int ilev = nlev - 1; ilev >= 0; ilev--) in mastrfu()
61 for (int n = ilev; n < nlev - 1; n++) in mastrfu()
106 const auto nlev = zaxisInqSize(zaxisID); in Mastrfu() local
123 Varray2D<double> array1(nlev, Varray<double>(gridsize)); in Mastrfu()
124 Varray2D<double> array2(nlev, Varray<double>(gridsize)); in Mastrfu()
H A DNCL_wind.cc20 …ouble *u, double *v, double *lon, double *lat, size_t nlon, size_t nlat, size_t nlev, int boundOpt, in uv2dv_cfd_W() argument
33 for (size_t k = 0; k < nlev; ++k) in uv2dv_cfd_W()
63 for (size_t k = 0; k < nlev; ++k) in uv2vr_cfd_W()
202 const auto nlev = zaxisInqSize(zaxisIDu); in NCL_wind() local
240 Varray<double> arrayu(nlev * gridsizeuv); in NCL_wind()
241 Varray<double> arrayv(nlev * gridsizeuv); in NCL_wind()
242 Varray<double> arrayo(nlev * gridsizeuv); in NCL_wind()
288 for (int levelID = 0; levelID < nlev; ++levelID) in NCL_wind()
298 …uv2dv_cfd_W(missvalu, &arrayu[0], &arrayv[0], &lon[0], &lat[0], nlon, nlat, nlev, boundOpt, &array… in NCL_wind()
300 …uv2vr_cfd_W(missvalu, &arrayu[0], &arrayv[0], &lon[0], &lat[0], nlon, nlat, nlev, boundOpt, &array… in NCL_wind()
[all …]
/dports/math/libpgmath/flang-d07daf3/test/ncar_kernels/HOMME_remap_q_ppm/src/
H A Dprim_advection_mod.F90336 REAL(KIND=real_kind), intent(in) :: dp1(nx,nx,nlev), dp2(nx,nx,nlev)
368 dpo(nlev+k) = dpo(nlev+1-k)
413 ao(nlev+k) = ao(nlev+1-k)
446 inde = nlev-1
449 inde = nlev+1
459 inde = nlev-2
462 inde = nlev
511 inde = nlev
524 inde = nlev
547 coefs(0,nlev-1:nlev) = a(nlev-1:nlev)
[all …]
/dports/science/getdp/getdp-3.4.0-source/contrib/Sparskit/
H A Dreordering.f16 * nlev)
19 * nlev,maskval
83 nlev = 0
102 1 nlev = nlev+1
103 levels(nlev) = istart + 1
124 3 levels(nlev+1) = iend+1
218 * nlev,riord,levels)
265 do j=levels(nlev),levels(nlev+1)-1
273 nlevp = nlev
305 integer nlev,riord(*),levels(nlev+1),ip,map(*),
[all …]
/dports/math/libpgmath/flang-d07daf3/test/ncar_kernels/HOMME_preq_omega_ps/src/
H A Dprim_si_mod.F9044 USE dimensions_mod, ONLY: nlev
48 REAL(KIND=real_kind), intent(in) :: divdp(np,np,nlev) ! divergence
49 REAL(KIND=real_kind), intent(in) :: vgrad_p(np,np,nlev) ! v.grad(p)
50 REAL(KIND=real_kind), intent(in) :: p(np,np,nlev) ! layer thicknesses (pressure)
52 REAL(KIND=real_kind), intent(out) :: omega_p(np,np,nlev) ! vertical pressure velocity
72 DO k=2,nlev-1
84 ckk = 0.5d0/p(i,j,nlev)
86 term = divdp(i,j,nlev)
88 omega_p(i,j,nlev) = vgrad_p(i,j,nlev)/p(i,j,nlev)
89 omega_p(i,j,nlev) = omega_p(i,j,nlev) - ckl*suml(i,j) - ckk*term
/dports/math/libpgmath/flang-d07daf3/test/ncar_kernels/HOMME_preq_hydrostatic/src/
H A Dprim_si_mod.F9057 USE dimensions_mod, ONLY: nlev
62 REAL(KIND=real_kind), intent(out) :: phi(np,np,nlev)
64 REAL(KIND=real_kind), intent(in) :: t_v(np,np,nlev)
65 REAL(KIND=real_kind), intent(in) :: p(np,np,nlev)
66 REAL(KIND=real_kind), intent(in) :: dp(np,np,nlev)
75 REAL(KIND=real_kind), dimension(np,np,nlev) :: phii ! Geopotential at interfaces
79 hkk = dp(i,j,nlev)*0.5d0/p(i,j,nlev)
81 phii(i,j,nlev) = rgas*t_v(i,j,nlev)*hkl
82 phi(i,j,nlev) = phis(i,j) + rgas*t_v(i,j,nlev)*hkk
84 DO k=nlev-1,2,-1
/dports/graphics/vcg/vcg.1.30/demo/
H A Dvcgdemomaker.c551 nlev = 2;
559 nlev += 1;
563 snode += nlev;
608 nlev = 2;
616 nlev += 1;
668 nlev = 2;
677 nlev += 1;
702 nlev += 1;
744 nlev = 2;
753 nlev += 1;
[all …]
/dports/math/R-cran-DoE.base/DoE.base/R/
H A Doa_feasible.R3 nlev <- nlevels functionVar
5 if (!all(c(nruns,nlev)>0)) stop("nruns, nlev and strength must be positive")
8 nfac <- length(nlev)
15 tablev <- table(nlev)
90 sT <- sum(nlev)
91 sM <- max(nlev)
92 sm <- min(nlev)
103 bound <- sum(nlev - 1) + 1 ## df for up to main effects
110 bound <- bound + max(sapply(1:nfac, function(obj) (nlev[obj] - 1)*sum(nlev[-obj] - 1)))
123 prod(nlev[sets[,obj]] - 1)
[all …]
/dports/science/cdcl/dcl-5.4.8-C/src/grph2/udpack/
H A Dudiclv.c43 ityp, char *clv, real *hl, integer *nlev, logical *lset, ftnlen in udiclv_0_() argument
111 if (! (1 <= *nlev && *nlev <= udblk2_1.nl)) { in udiclv_0_()
115 do_fio(&c__1, (char *)&(*nlev), (ftnlen)sizeof(integer)); in udiclv_0_()
122 *zlev = udblk2_1.czl[*nlev - 1]; in udiclv_0_()
123 *indx = udblk2_1.idx[*nlev - 1]; in udiclv_0_()
124 *ityp = udblk2_1.ity[*nlev - 1]; in udiclv_0_()
125 *hl = udblk2_1.hlv[*nlev - 1]; in udiclv_0_()
131 *nlev = udblk2_1.nl; in udiclv_0_()
180 clv, real *hl, integer *nlev, ftnlen clv_len) in udqclv_() argument
186 /* Subroutine */ int udqcln_(integer *nlev) in udqcln_() argument
[all …]
/dports/science/apbs/apbs-pdb2pqr-apbs-1.5-102-g500c1473/apbs/externals/fetk/punc/src/pmg/src_f77/
H A Dmgdrvd.f93 nlev = iparm(6)
103 if (nlev.gt.mxlv) then
210 nlev = iparm(6)
233 call buildstr (nx,ny,nz,nlev,iz)
274 nlev_real = nlev
388 nlev_real = nlev
407 nlev_real = nlev
541 do 10 level = 2, nlev
593 n_rpc = 100*(nlev+1)
603 n_iz = 50*(nlev+1)
[all …]
H A Dcgmgdrvd.f82 integer nrwk,niwk,nx,ny,nz,nlev,ierror,maxlev,mxlv local
93 nlev = iparm(6)
96 if ((nlev.le.0).or.(nx.le.0).or.(ny.le.0).or.(nz.le.0)) then
103 if (nlev.gt.mxlv) then
114 call mgsz(mgcoar,mgdisc,mgsolv,nx,ny,nz,nlev,nxc,nyc,nzc,
208 nlev = iparm(6)
229 call buildstr (nx,ny,nz,nlev,iz)
236 call buildops (nx,ny,nz,nlev,ipkey,iinfo,ido,iz,
250 call buildops (nx,ny,nz,nlev,ipkey,iinfo,ido,iz,
264 call buildALG (nx,ny,nz,mode,nlev,iz,
[all …]
H A Dnewdrvd.f82 integer nrwk,niwk,nx,ny,nz,nlev,ierror,maxlev,mxlv local
93 nlev = iparm(6)
96 if ((nlev.le.0).or.(nx.le.0).or.(ny.le.0).or.(nz.le.0)) then
103 if (nlev.gt.mxlv) then
114 call mgsz(mgcoar,mgdisc,mgsolv,nx,ny,nz,nlev,nxc,nyc,nzc,
209 nlev = iparm(6)
230 call buildstr (nx,ny,nz,nlev,iz)
237 call buildops (nx,ny,nz,nlev,ipkey,iinfo,ido,iz,
251 call buildops (nx,ny,nz,nlev,ipkey,iinfo,ido,iz,
265 call buildALG (nx,ny,nz,mode,nlev,iz,
[all …]
/dports/science/apbs/apbs-pdb2pqr-apbs-1.5-102-g500c1473/apbs/src/pmgc/
H A Dmgdrvd.c79 int nlev = 0; in Vmgdriv() local
108 nlev = VAT(iparm, 6); in Vmgdriv()
111 VASSERT_MSG1(nlev > 0, "nlev must be positive: %d", nlev); in Vmgdriv()
118 nlev <= mxlv, in Vmgdriv()
120 nlev, mxlv in Vmgdriv()
131 &nlev, in Vmgdriv()
262 MAT2(iz, 50, nlev); in Vmgdriv2()
336 nlev_real = nlev; in Vmgdriv2()
485 nlev_real = nlev; in Vmgdriv2()
516 nlev_real = nlev; in Vmgdriv2()
[all …]
H A Dnewdrvd.c79 int nlev; /// @todo: Doc in Vnewdriv() local
102 nlev = VAT(iparm, 6); in Vnewdriv()
121 &nlev, in Vnewdriv()
176 int nlev; /// @todo: Doc in Vnewdriv2() local
223 nlev = VAT(iparm, 6); in Vnewdriv2()
244 Vbuildstr(nx, ny, nz, &nlev, iz); in Vnewdriv2()
252 &nlev, &ipkey, &iinfo, &ido, iz, in Vnewdriv2()
270 &nlev, &ipkey, &iinfo, &ido, iz, in Vnewdriv2()
293 &mode, &nlev, iz, in Vnewdriv2()
309 nlev_real = nlev; in Vnewdriv2()
[all …]
/dports/math/R-cran-statmod/statmod/R/
H A Dgrowthcurve.R54 nlev <- length(lev) functionVar
55 if(nlev < 2) stop("Less than 2 groups to compare")
60 g1 <- g2 <- rep("",nlev*(nlev-1)/2)
61 stat <- pvalue <- rep(0,nlev*(nlev-1)/2)
63 for (i in 1:(nlev-1)) {
64 for (j in (i+1):nlev) {
89 nlev <- length(levels) functionVar
90 if(nlev < 2) stop("Less than 2 groups to compare")
95 if(is.null(col)) col <- 1:nlev
/dports/science/cdcl/dcl-5.4.8-C/src/math1/syslib/
H A Dprcopn.c25 /* Subroutine */ int prcopn_0_(int n__, char *cproc, integer *nlev, ftnlen in prcopn_0_() argument
86 *nlev = nlevel; in prcopn_0_()
91 if (*nlev <= nlevel) { in prcopn_0_()
92 s_copy(cproc, cprocz + (*nlev << 5), cproc_len, (ftnlen)32); in prcopn_0_()
119 /* Subroutine */ int prclvl_(integer *nlev) in prclvl_() argument
121 return prcopn_0_(2, (char *)0, nlev, (ftnint)0); in prclvl_()
124 /* Subroutine */ int prcnam_(integer *nlev, char *cproc, ftnlen cproc_len) in prcnam_() argument
126 return prcopn_0_(3, cproc, nlev, cproc_len); in prcnam_()
/dports/biology/gemma/GEMMA-0.98.3/src/
H A Dlogistic.h8 gsl_vector_int *nlev, // Vector with num. categories.
17 gsl_vector_int *nlev, // Vector with number categories.
24 double fLogit_mixed(gsl_vector *beta, gsl_matrix_int *X, gsl_vector_int *nlev,
32 gsl_vector_int *nlev, // Vector with number categories.
39 gsl_vector_int *nlev, // Vector with number categories.
44 double fLogit_cat(gsl_vector *beta, gsl_matrix_int *X, gsl_vector_int *nlev,
/dports/math/libpgmath/flang-d07daf3/test/ncar_kernels/CAM5_mg2_pgi/src/
H A Dmicro_mg2_0.F90533 REAL(KIND=r8) :: fc(nlev)
535 REAL(KIND=r8) :: fi(nlev)
651 DO k=1,nlev
1460 DO k=1,nlev
1570 DO k = 2,nlev
1620 DO k = 2,nlev
1661 DO k = 2,nlev
1694 DO k = 2,nlev
1712 DO k=1,nlev
1982 DO k=1,nlev
[all …]
/dports/math/libpgmath/flang-d07daf3/test/ncar_kernels/HOMME_div_sphere/src/
H A Dkernel_divergence_sphere.F9046 INTEGER , PARAMETER :: nlev = 20 variable
49 REAL(KIND=real_kind) u(np,np,nlev)
50 REAL(KIND=real_kind) t(np,np,nlev)
51 REAL(KIND=real_kind) ke(np,np,nlev)
67 REAL(KIND=real_kind) uv(np,np,2,nlev)
70 REAL(KIND=real_kind) psi(np,np,nlev)
71 REAL(KIND=real_kind) phi(np,np,nlev)
72 REAL(KIND=real_kind) ht(np,np,nlev)
75 REAL(KIND=real_kind) pt3d(np,np,nlev)
76 REAL(KIND=real_kind) qt3d(np,np,nlev)
[all …]
/dports/graphics/osg34/OpenSceneGraph-OpenSceneGraph-3.4.1/examples/osghangglide/
H A Dsky.cpp54 int nlev = sizeof( lev )/sizeof(float); in makeSky() local
58 Vec3Array& coords = *(new Vec3Array(19*nlev)); in makeSky()
59 Vec4Array& colors = *(new Vec4Array(19*nlev)); in makeSky()
60 Vec2Array& tcoords = *(new Vec2Array(19*nlev)); in makeSky()
65 for( i = 0; i < nlev; i++ ) in makeSky()
86 tcoords[ci][1] = (float)i/(float)(nlev-1); in makeSky()
94 for( i = 0; i < nlev-1; i++ ) in makeSky()

12345678910>>...18