Home
last modified time | relevance | path

Searched refs:phi_p (Results 1 – 25 of 129) sorted by relevance

123456

/dports/math/xlife++/xlifepp-sources-v2.0.1-2018-05-09/src/term/
H A DTensorKernel.hpp147 phi_p=φ in TensorKernel()
148 psi_p=phi_p; in TensorKernel()
163 phi_p=φ in TensorKernel()
185 psi_p=phi_p; in TensorKernel()
245 psi_p = phi_p; in TensorKernel()
275 phi_p = new SpectralBasisFun(fs,n); in TensorKernel()
276 if(&fs == &gs) psi_p = phi_p; in TensorKernel()
310 phi_p = new SpectralBasisInt(phis); in TensorKernel()
311 psi_p =phi_p; in TensorKernel()
312 if(mat.size()<phi_p->numberOfFun()) in TensorKernel()
[all …]
H A DTensorKernel.cpp36 phi_p=tk.phi_p; in TensorKernel()
39 if(phi_p!=0) phi_p=tk.phi_p->clone(); in TensorKernel()
42 if(tk.psi_p!=tk.phi_p) psi_p=tk.psi_p->clone(); in TensorKernel()
43 else psi_p=phi_p; in TensorKernel()
64 if(phi_p!=0) delete phi_p; in ~TensorKernel()
65 if(psi_p!=0 && psi_p!=phi_p) delete psi_p; in ~TensorKernel()
72 if(phi_p->valueType()==_complex) return _complex; in valueType()
79 if(phi_p->strucType()==_vector || psi_p->strucType()==_vector) return _matrix; in strucType()
87 os<<" phi(y) : "<< (*phi_p)<<eol; in print()
/dports/lang/pocl/pocl-1.8/examples/scalarwave/
H A Dscalarwave.cl31 global double const *restrict const phi_p,
95 2.0 * phi_p[ind3d] - phi_p_p[ind3d] +
96 dt2 * ((phi_p[ind3d-di] - 2.0*phi_p[ind3d] + phi_p[ind3d+di]) * idx2 +
97 (phi_p[ind3d-dj] - 2.0*phi_p[ind3d] + phi_p[ind3d+dj]) * idy2 +
98 (phi_p[ind3d-dk] - 2.0*phi_p[ind3d] + phi_p[ind3d+dk]) * idz2);
H A Dscalarwave.c45 cl_double const *const phi_p, in exec_scalarwave_kernel() argument
89 npoints*sizeof(*phi_p), (cl_double*)phi_p, NULL); in exec_scalarwave_kernel()
175 cl_double *restrict phi_p = (cl_double*) in main() local
176 malloc (grid.ai*grid.aj*grid.ak * sizeof *phi_p ); in main()
196 phi_p[ind3d] = sin(kx*x) * sin(ky*y) * sin(kz*z) * cos(omega*t1); in main()
208 phi_p_p = phi_p; in main()
209 phi_p = phi; in main()
216 exec_scalarwave_kernel (source, phi, phi_p, phi_p_p, &grid); in main()
243 free (phi_p); in main()
/dports/graphics/proj/proj-7.2.1/src/projections/
H A Docea.cpp62 double lam_p, phi_p; in PROJECTION() local
76 phi_p = asin(cos(P->phi0) * sin(alpha)); in PROJECTION()
100 phi_p = (cos_lamp_m_minus_lam_1 >= 0.0 ) ? -M_HALFPI : M_HALFPI; in PROJECTION()
103 phi_p = atan(- cos_lamp_m_minus_lam_1 / tan_phi_1); in PROJECTION()
107 Q->cosphi = cos(phi_p); in PROJECTION()
108 Q->sinphi = sin(phi_p); in PROJECTION()
/dports/science/healpix/Healpix_3.50/src/idl/zzz_external/astron/
H A Dwcs_getpole.pro24 ; i.e. lonpole = phi_p - phi_0.
79 phi_p = double(lonpole)/radeg
81 sp = sin(phi_p)
82 cp = cos(phi_p)
101 pi2: alpha_p += phi_p - !dpi
102 -pi2: alpha_p -= phi_p
107 alpha_p = alpha_0 + phi_p - !dpi
131 if (sdelt EQ 1) then alpha_p = alpha_0 - phi_p - !DPI else $
132 if (sdelt EQ -1) then alpha_p = alpha_0 -phi_p else $
/dports/science/code_saturne/code_saturne-7.1.0/src/lagr/
H A Dcs_lagr_clogging.c120 const cs_real_t *phi_p, in cloginit() argument
142 cs_lagr_clogging_param.phi_p = *phi_p; in cloginit()
306 cs_lagr_clogging_param.phi_p, in cs_lagr_clogging_barrier()
348 cs_lagr_clogging_param.phi_p, in cs_lagr_clogging_barrier()
349 cs_lagr_clogging_param.phi_p, in cs_lagr_clogging_barrier()
H A Dcs_lagr_dlvo.c123 const cs_real_t phi_p, in cs_lagr_dlvo_init() argument
139 cs_lagr_dlvo_param.phi_p = phi_p; in cs_lagr_dlvo_init()
175 bft_printf(" phi_p = %g\n", cs_lagr_dlvo_param.phi_p); in cs_lagr_dlvo_init()
235 cs_lagr_dlvo_param.phi_p, in cs_lagr_barrier()
287 cs_lagr_dlvo_param.phi_p, in cs_lagr_barrier_pp()
288 cs_lagr_dlvo_param.phi_p, in cs_lagr_barrier_pp()
H A Dcs_lagr_roughness.c86 .phi_p = 0,
129 const cs_real_t *phi_p, in roughness_init() argument
148 cs_lagr_roughness_param->phi_p = *phi_p; in roughness_init()
187 bft_printf(" phi_p = %g\n", cs_lagr_roughness_param->phi_p); in roughness_init()
396 cs_lagr_roughness_param->phi_p, in cs_lagr_roughness_barrier()
421 cs_lagr_roughness_param->phi_p, in cs_lagr_roughness_barrier()
H A Dcs_lagr_roughness.h47 cs_real_t phi_p; member
78 const cs_real_t *phi_p,
H A Dcs_lagr_clogging.h53 cs_real_t phi_p; member
83 const cs_real_t *phi_p,
H A Dcs_lagr_adh.c160 cs_real_t phi_p, in _edlsp() argument
172 cs_real_t lphi1 = lag_pc->valen * charge * phi_p / _k_boltz / tempf; in _edlsp()
533 _edlsp(&distp, &rpart, lag_pc->phi_p, lag_pc->phi_s, tempf, &uedlsp); in cs_lagr_adh()
553 _edlss(&distcc, &rpart, &rayasp, lag_pc->phi_p, lag_pc->phi_s, tempf, &uedlss); in cs_lagr_adh()
578 _edlss(&distcc, &rpart, &rayasg, lag_pc->phi_p, lag_pc->phi_s, tempf, &uedlss); in cs_lagr_adh()
681 _edlss(&distcc, &rpart, &rpart, lag_pc->phi_p, lag_pc->phi_p, tempf, &uedlss); in cs_lagr_adh_pp()
H A Dcs_lagr_dlvo.h50 cs_real_t phi_p; member
74 const cs_real_t phi_p,
/dports/science/dynare/dynare-4.6.4/tests/deterministic_simulations/linear_approximation/
H A Dsw.mod5 …rv_p l_bar pi_bar beta_const Mu_w Mu_p alpha psi phi delta sigma_c lambda phi_p iota_w xi_w iota_p…
22 phi_p = 1.4672;
49 # W = (alpha^alpha*(1-alpha)^(1-alpha)/(phi_p*Rk^alpha))^(1/(1-alpha));
53 # K_Y = phi_p*(L_K)^(alpha-1);
67 yf = phi_p*( alpha*kf+(1-alpha)*labf +eps_a );
78 y = phi_p * (alpha * k_s + (1-alpha) * l + eps_a);
79 …*pinf(+1) + iota_p * pinf(-1) + ((1-xi_p)*(1-beta_bar*gamma*xi_p)/xi_p)/((phi_p-1)*curv_p+1) * mc)…
/dports/science/dynare/dynare-4.6.4/tests/lmmcp/
H A Dsw_lmmcp.mod9 # W = (alpha^alpha*(1-alpha)^(1-alpha)/(phi_p*Rk^alpha))^(1/(1-alpha));
13 # K_Y = phi_p*(L_K)^(alpha-1);
27 yf = phi_p*( alpha*kf+(1-alpha)*labf +eps_a );
38 y = phi_p * (alpha * k_s + (1-alpha) * l + eps_a);
39 …*pinf(+1) + iota_p * pinf(-1) + ((1-xi_p)*(1-beta_bar*gamma*xi_p)/xi_p)/((phi_p-1)*curv_p+1) * mc)…
H A Dsw_newton.mod9 # W = (alpha^alpha*(1-alpha)^(1-alpha)/(phi_p*Rk^alpha))^(1/(1-alpha));
13 # K_Y = phi_p*(L_K)^(alpha-1);
27 yf = phi_p*( alpha*kf+(1-alpha)*labf +eps_a );
38 y = phi_p * (alpha * k_s + (1-alpha) * l + eps_a);
39 …*pinf(+1) + iota_p * pinf(-1) + ((1-xi_p)*(1-beta_bar*gamma*xi_p)/xi_p)/((phi_p-1)*curv_p+1) * mc)…
H A Dsw-common-header.inc5 …rv_p l_bar pi_bar beta_const Mu_w Mu_p alpha psi phi delta sigma_c lambda phi_p iota_w xi_w iota_p…
22 phi_p = 1.4672;
/dports/science/py-gpaw/gpaw-21.6.0/c/xc/
H A Dvdw.c184 const double* phi_p = phi_jp + 4 * j_k[k]; in vdw2() local
185 double a = phi_p[0]; in vdw2()
186 double b = phi_p[1]; in vdw2()
187 double c = phi_p[2]; in vdw2()
188 double d = phi_p[3]; in vdw2()
/dports/science/dynare/dynare-4.6.4/tests/simul/
H A Dsimul_ZLB_purely_forward.mod4 parameters alpha, beta, sigma, gamma, theta, ni, tau_w, phi_p, phi_y;
12 phi_p = 1.5;
38 R=max(0,r_e+phi_p*pi+phi_y*gdp_hat);
H A Dsimul_ZLB_purely_forward_no_solution.mod4 parameters alpha, beta, sigma, gamma, theta, ni, tau_w, phi_p, phi_y;
12 phi_p = 1.5;
38 R=max(0,r_e+phi_p*pi+phi_y*gdp_hat);
/dports/math/openturns/openturns-1.18/python/doc/theory/reliability_sensitivity/
H A Doptimal_lhs.rst48 - In practice, the :math:`\phi_p` criterion is used instead of mindist and writes:
51 …\phi_p(X) = \left( \sum_{1\leq i < j \leq N} ||x^{(i)} - x^{(j)}||^{-p}_{L^2} \right)^{\frac{1}{p}}
53 …e more robust. When p tends to infinity, optimizing a design with :math:`\phi_p` is equivalent to …
75 …, has a complexity of :math:`\mathcal{O}(d\times N^2)` for :math:`C_2` and :math:`\phi_p` criteria.
120 The same trick can also be applied on :math:`\phi_p` criterion, because we can write
124 \phi_p(X)^p
144 \phi_p(X_{d}^{\prime N})^p = \phi_p(X_{d}^N)^p
/dports/math/dune-pdelab/dune-pdelab-20c7085389d3eb4f8ca99e1bc60f7fa6036536c8/dune/pdelab/localoperator/
H A Ddgnavierstokes.hh134 std::vector<RT> phi_p(psize); in alpha_volume() local
158 FESwitch_P::basis(lfsv_p.finiteElement()).evaluateFunction(local,phi_p); in alpha_volume()
163 p += x(lfsv_p,i) * phi_p[i]; in alpha_volume()
267 std::vector<RT> phi_p(psize); in jacobian_volume() local
841 std::vector<RT> phi_p(psize); in alpha_boundary() local
847 p += x(lfsv_p,i) * phi_p[i]; in alpha_boundary()
1002 std::vector<RT> phi_p(psize); in jacobian_boundary() local
1185 std::vector<RT> phi_p(psize); in lambda_volume() local
1222 r.accumulate(lfsv_p,i, g2 * phi_p[i] * factor); in lambda_volume()
1278 std::vector<RT> phi_p(psize); in lambda_boundary() local
[all …]
/dports/finance/py-quantecon/quantecon-0.5.2/quantecon/
H A Darma.py83 for (tm, phi_p) in enumerate(phi):
85 if abs(phi_p) > 1e-12:
86 rhs += r"%+g X_{t-%i}" % (phi_p, tm+1)
/dports/science/dynare/dynare-4.6.4/matlab/
H A Dautoregressive_process_specification.m18 % y_t = \phi_1 * y_{t-1} + \phi_2 * y_{t-2} + ... + \phi_p * y_{t-p} + e_t
24 % \gamma(0) = \phi_1 \gamma(1) + ... + \phi_p \gamma(p) + \sigma^2
28 % \sigma^2 = \gamma(0) (1-\rho(1)\phi_1 - ... - \rho(p)\phi_p)
32 % \rho(h) = \phi_1 \rho(h-1) + ... + \phi_p \rho(h-p)
/dports/math/deal.ii/dealii-803d21ff957e349b3799cd3ef2c840bc78734305/examples/step-57/
H A Dstep-57.cc400 std::vector<double> phi_p(dofs_per_cell); in assemble() local
432 phi_p[k] = fe_values[pressure].value(k, q); in assemble()
447 div_phi_u[i] * phi_p[j] - phi_p[i] * div_phi_u[j] + in assemble()
449 phi_p[i] * phi_p[j]) * in assemble()
462 present_velocity_divergence * phi_p[i] - in assemble()

123456