Home
last modified time | relevance | path

Searched refs:alpha_n (Results 1 – 25 of 52) sorted by relevance

123

/dports/misc/elki/elki-release0.7.1-1166-gfb1fffdf3/elki/src/main/java/de/lmu/ifi/dbs/elki/algorithm/clustering/correlation/cash/
H A DParameterizationFunction.java252 if(lower <= alpha_n && alpha_n <= upper) { in determineAlphaMin()
253 return alpha_n; in determineAlphaMin()
269 if(lower <= alpha_n && alpha_n <= upper) { in determineAlphaMin()
271 if(alpha_n - lower <= upper - alpha_n) { in determineAlphaMin()
314 if(lower <= alpha_n && alpha_n <= upper) { in determineAlphaMax()
316 if(alpha_n - lower <= upper - alpha_n) { in determineAlphaMax()
339 if(lower <= alpha_n && alpha_n <= upper) { in determineAlphaMax()
340 return alpha_n; in determineAlphaMax()
508 if(alpha_n < 0) { in extremum_alpha_n()
509 alpha_n = Math.PI + alpha_n; in extremum_alpha_n()
[all …]
/dports/science/PETSc/petsc-3.14.1/src/ts/tutorials/
H A Dex53.c790 …etscSinReal(alpha_n) * PetscCosReal(alpha_n)) / (alpha_n - PetscSinReal(alpha_n) * PetscCosReal(al… in mandel_initial_u()
791 …osReal(alpha_n) / (alpha_n - PetscSinReal(alpha_n)*PetscCosReal(alpha_n))) * PetscSinReal( (alpha_… in mandel_initial_u()
874 …tscSinReal(alpha_n) * PetscCosReal(alpha_n)) / (alpha_n - PetscSinReal(alpha_n) * PetscCosReal(alp… in mandel_2d_u()
875 …osReal(alpha_n) / (alpha_n - PetscSinReal(alpha_n)*PetscCosReal(alpha_n))) * PetscSinReal( (alpha_… in mandel_2d_u()
1018alpha_n*alpha_n*c*PetscExpReal( (-1.0*alpha_n*alpha_n*time)/(a*a))*PetscSinReal( (alpha_n*x[0])/a)… in mandel_2d_u_t()
1019alpha_n*alpha_n*c*PetscExpReal( (-1.0*alpha_n*alpha_n*time)/(a*a))*PetscSinReal( alpha_n) * Petsc… in mandel_2d_u_t()
1067alpha_n*alpha_n*alpha_n*c*PetscExpReal( (-1.0*alpha_n*alpha_n*c*time)/(a*a))*PetscCosReal(alpha_n)… in mandel_2d_eps_t()
1068alpha_n*alpha_n*c*PetscExpReal( (-1.0*alpha_n*alpha_n*c*time)/(a*a))*PetscSinReal(alpha_n)*PetscCo… in mandel_2d_eps_t()
1069alpha_n*alpha_n*c*PetscExpReal( (-1.0*alpha_n*alpha_n*c*time)/(a*a))*PetscSinReal(alpha_n)*PetscCo… in mandel_2d_eps_t()
1115alpha_n*alpha_n*c*( -1.0*PetscCosReal(alpha_n) + PetscCosReal( (alpha_n*x[0])/a))*PetscExpReal( (-… in mandel_2d_p_t()
[all …]
/dports/math/R-cran-MCMCpack/MCMCpack/src/
H A DcMCMCpaircompare.cc70 …Matrix<unsigned int> alpha_n(I,1,true,0); // vector of 0s. Judge i's total instances of making com… in MCMCpaircompare_impl() local
72 alpha_n(MD(i,0)) += 1; in MCMCpaircompare_impl()
120 Ystar_i_ptr.reserve(alpha_n(i)); in MCMCpaircompare_impl()
121 theta1_i_ptr.reserve(alpha_n(i)); in MCMCpaircompare_impl()
122 theta2_i_ptr.reserve(alpha_n(i)); in MCMCpaircompare_impl()
191 alpha_n, in MCMCpaircompare_impl()
/dports/comms/gnuradio/gnuradio-3.8.4.0/gr-channels/lib/
H A Dflat_fader_impl.cc80 float alpha_n = (2 * GR_M_PI * n - GR_M_PI + d_theta) / (4 * d_N); in next_samples() local
82 fmod(d_psi[n] + 2 * GR_M_PI * d_fDTs * _GRFASTCOS(alpha_n), 2 * GR_M_PI); in next_samples()
84 fmod(d_phi[n] + 2 * GR_M_PI * d_fDTs * _GRFASTCOS(alpha_n), 2 * GR_M_PI); in next_samples()
/dports/science/nest/nest-simulator-3.1/models/
H A Dhh_cond_exp_traub.cpp105 const double alpha_n = 0.032 * ( 15. - V ) / ( std::exp( ( 15. - V ) / 5. ) - 1. ); in hh_cond_exp_traub_dynamics() local
114 f[ S::HH_N ] = alpha_n - ( alpha_n + beta_n ) * y[ S::HH_N ]; // n-variable in hh_cond_exp_traub_dynamics()
155 const double alpha_n = 0.032 * ( 15. - y_[ 0 ] ) / ( std::exp( ( 15. - y_[ 0 ] ) / 5. ) - 1. ); in State_() local
163 y_[ HH_N ] = alpha_n / ( alpha_n + beta_n ); in State_()
H A Dhh_psc_alpha.cpp96 const double alpha_n = ( 0.01 * ( V + 55. ) ) / ( 1. - std::exp( -( V + 55. ) / 10. ) ); in hh_psc_alpha_dynamics() local
113 f[ S::HH_N ] = alpha_n * ( 1 - y[ S::HH_N ] ) - beta_n * y[ S::HH_N ]; // n-variable in hh_psc_alpha_dynamics()
154 …const double alpha_n = ( 0.01 * ( y_[ 0 ] + 55. ) ) / ( 1. - std::exp( -( y_[ 0 ] + 55. ) / 10. ) … in State_() local
162 y_[ HH_N ] = alpha_n / ( alpha_n + beta_n ); in State_()
H A Dhh_cond_beta_gap_traub.cpp137 const double alpha_n = 0.032 * ( 15. - V ) / ( std::exp( ( 15. - V ) / 5. ) - 1. ); in hh_cond_beta_gap_traub_dynamics() local
146 f[ S::HH_N ] = alpha_n - ( alpha_n + beta_n ) * y[ S::HH_N ]; // n-variable in hh_cond_beta_gap_traub_dynamics()
194 const double alpha_n = 0.032 * ( 15. - y_[ 0 ] ) / ( std::exp( ( 15. - y_[ 0 ] ) / 5. ) - 1. ); in State_() local
202 y_[ HH_N ] = alpha_n / ( alpha_n + beta_n ); in State_()
H A Dhh_psc_alpha_clopath.cpp102 const double alpha_n = ( 0.01 * ( V + 55. ) ) / ( 1. - std::exp( -( V + 55. ) / 10. ) ); in hh_psc_alpha_clopath_dynamics() local
119 f[ S::HH_N ] = alpha_n * ( 1 - y[ S::HH_N ] ) - beta_n * y[ S::HH_N ]; // n-variable in hh_psc_alpha_clopath_dynamics()
168 …const double alpha_n = ( 0.01 * ( y_[ 0 ] + 55. ) ) / ( 1. - std::exp( -( y_[ 0 ] + 55. ) / 10. ) … in State_() local
176 y_[ HH_N ] = alpha_n / ( alpha_n + beta_n ); in State_()
H A Dhh_psc_alpha_gap.cpp103 const double alpha_n = 0.014 * ( V + 44. ) / ( 1. - std::exp( -( V + 44. ) / 2.3 ) ); in hh_psc_alpha_gap_dynamics() local
145 f[ S::HH_N ] = alpha_n * ( 1 - y[ S::HH_N ] ) - beta_n * y[ S::HH_N ]; // n-variable in hh_psc_alpha_gap_dynamics()
195 const double alpha_n = 0.014 * ( y_[ 0 ] + 44. ) / ( 1. - std::exp( -( y_[ 0 ] + 44. ) / 2.3 ) ); in State_() local
199 y_[ HH_N ] = alpha_n / ( alpha_n + beta_n ); in State_()
/dports/math/openturns/openturns-1.18/python/src/
H A DAdaptiveStieltjesAlgorithm_doc.i.in28 …a_n = 1/\sqrt{\beta_{n+1}}\quad b_n = -\alpha_n/sqrt{\beta_{n+1}}\quad c_n = -\sqrt{\beta_n/\beta_…
30 where :math:`\alpha_n = S_n / R_n` and :math:`\beta_n = R_n / R_{n-1}, n>0, \beta_0 = 0`.
H A DOrdinalSumCopula_doc.i.in30 and where, for convenience, we noted :math:`\alpha_0=0` and :math:`\alpha_n=1`.
/dports/math/blasfeo/blasfeo-0.1.2/kernel/generic/
H A Dkernel_dsymv_4_lib4.c40 void kernel_dgemv_nt_4_vs_lib4(int kmax, double *alpha_n, double *alpha_t, double *A, int sda, doub… in kernel_dgemv_nt_4_vs_lib4() argument
60 x_n_0 = alpha_n[0]*x_n[0]; in kernel_dgemv_nt_4_vs_lib4()
63 x_n_1 = alpha_n[0]*x_n[1]; in kernel_dgemv_nt_4_vs_lib4()
66 x_n_2 = alpha_n[0]*x_n[2]; in kernel_dgemv_nt_4_vs_lib4()
69 x_n_3 = alpha_n[0]*x_n[3]; in kernel_dgemv_nt_4_vs_lib4()
230 void kernel_dgemv_nt_4_lib4(int kmax, double *alpha_n, double *alpha_t, double *A, int sda, double … in kernel_dgemv_nt_4_lib4() argument
233 kernel_dgemv_nt_4_vs_lib4(kmax, alpha_n, alpha_t, A, sda, x_n, x_t, beta_t, y_t, z_n, z_t, 4); in kernel_dgemv_nt_4_lib4()
H A Dkernel_ssymv_4_lib4.c40 void kernel_sgemv_nt_4_vs_lib4(int kmax, float *alpha_n, float *alpha_t, float *A, int sda, float *… in kernel_sgemv_nt_4_vs_lib4() argument
60 x_n_0 = alpha_n[0]*x_n[0]; in kernel_sgemv_nt_4_vs_lib4()
63 x_n_1 = alpha_n[0]*x_n[1]; in kernel_sgemv_nt_4_vs_lib4()
66 x_n_2 = alpha_n[0]*x_n[2]; in kernel_sgemv_nt_4_vs_lib4()
69 x_n_3 = alpha_n[0]*x_n[3]; in kernel_sgemv_nt_4_vs_lib4()
230 void kernel_sgemv_nt_4_lib4(int kmax, float *alpha_n, float *alpha_t, float *A, int sda, float *x_n… in kernel_sgemv_nt_4_lib4() argument
233 kernel_sgemv_nt_4_vs_lib4(kmax, alpha_n, alpha_t, A, sda, x_n, x_t, beta_t, y_t, z_n, z_t, 4); in kernel_sgemv_nt_4_lib4()
/dports/games/simutrans/simutrans-121.0/display/
H A Dsimgraph.h199 void display_rezoomed_img_alpha(const image_id n, const image_id alpha_n, const unsigned alpha_flag…
218 void display_base_img_alpha(const image_id n, const image_id alpha_n, const unsigned alpha_flags, K…
223 typedef void (*display_alpha_proc)(const image_id n, const image_id alpha_n, const unsigned alpha_f…
/dports/science/elmerfem/elmerfem-release-9.0/fem/src/modules/
H A DThermoElectricSolver.F90133 REAL(KIND=dp) :: sigma_n(3,3,n),alpha_n(3,3,n), pelt_n(3,3,n), & local
146 CALL InputTensor(Material, alpha_n, isScalar,'Seebeck Coefficient', Element)
192 alpha(i,j) = SUM(alpha_n(i,j,:)*Basis(1:n))
/dports/science/libxc/libxc-5.0.0/maple/lda_exc/
H A Dlda_c_pk09.mpl42 alpha_n := rs ->
48 alpha_eff := (rs, z) -> alpha_n(rs)*alpha_z(rs, z):
/dports/textproc/texi2html/texi2html-5.0/test/singular_manual/
H A Dpdata.tex526 \alpha_n = \beta_n,
538 let $\deg(x^\alpha) = \alpha_1 + \cdots + \alpha_n,$ then
555 \deg(x^\beta)$ and $\exists\ 1 \le i \le n: \alpha_n = \beta_n,
567 let $\deg(x^\alpha) = \alpha_1 + \cdots + \alpha_n,$ then
605 $\deg(x^\alpha) = w_1 \alpha_1 + \cdots + w_n\alpha_n.$
625 $\deg(x^\alpha) = w_1 \alpha_1 + \cdots + w_n\alpha_n.$
681 let $\deg(x^\alpha) = \alpha_1 + \cdots + \alpha_n,$ then
710 let $\deg(x^\alpha) = \alpha_1 + \cdots + \alpha_n,$ then
756 $\deg(x^\alpha) = w_1 \alpha_1 + \cdots + w_n\alpha_n.$
784 $\deg(x^\alpha) = w_1 \alpha_1 + \cdots + w_n\alpha_n.$
[all …]
/dports/math/cado-nfs/cado-nfs-f4284e2391121b2bfb97bc4880b6273c7250dc2f/sieve/ecm/
H A Dcofac_utils.sage161 alpha_n = sigma2_n - 5*sigma2_d # u4
163 alpha3_n = alpha_n^3 # u5
188 alpha = alpha_n / alpha_d
/dports/math/octave-forge-control/control-3.3.1/inst/
H A Dacker.m37 ## $$ p(s) = s^n + \alpha_1 s^{n-1} + ... + \alpha_n $$
/dports/math/blasfeo/blasfeo-0.1.2/blasfeo_api/
H A Dd_blas2_lib4.c147 void dgemv_nt_lib(int m, int n, double alpha_n, double alpha_t, double *pA, int sda, double *x_n, d… in dgemv_nt_lib() argument
175 …kernel_dgemv_nt_6_lib4(m, &alpha_n, &alpha_t, pA+ii*bs, sda, x_n+ii, x_t, &beta_t, y_t+ii, z_n, z_… in dgemv_nt_lib()
180 …kernel_dgemv_nt_4_lib4(m, &alpha_n, &alpha_t, pA+ii*bs, sda, x_n+ii, x_t, &beta_t, y_t+ii, z_n, z_… in dgemv_nt_lib()
184 …kernel_dgemv_nt_4_vs_lib4(m, &alpha_n, &alpha_t, pA+ii*bs, sda, x_n+ii, x_t, &beta_t, y_t+ii, z_n,… in dgemv_nt_lib()
308 void blasfeo_dgemv_nt(int m, int n, double alpha_n, double alpha_t, struct blasfeo_dmat *sA, int ai… in blasfeo_dgemv_nt() argument
317 blasfeo_dgemv_n(m, n, alpha_n, sA, ai, aj, sx_n, xi_n, beta_n, sy_n, yi_n, sz_n, zi_n); in blasfeo_dgemv_nt()
329 dgemv_nt_lib(m, n, alpha_n, alpha_t, pA, sda, x_n, x_t, beta_n, beta_t, y_n, y_t, z_n, z_t); in blasfeo_dgemv_nt()
H A Ds_blas2_lib4.c125 void blasfeo_sgemv_nt(int m, int n, float alpha_n, float alpha_t, struct blasfeo_smat *sA, int ai, … in blasfeo_sgemv_nt() argument
169 …kernel_sgemv_nt_4_lib4(m, &alpha_n, &alpha_t, pA+ii*bs, sda, x_n+ii, x_t, &beta_t, y_t+ii, z_n, z_… in blasfeo_sgemv_nt()
173 …kernel_sgemv_nt_4_vs_lib4(m, &alpha_n, &alpha_t, pA+ii*bs, sda, x_n+ii, x_t, &beta_t, y_t+ii, z_n,… in blasfeo_sgemv_nt()
/dports/math/blasfeo/blasfeo-0.1.2/include/
H A Dblasfeo_s_kernel.h172 void kernel_sgemv_nt_4_lib8(int kmax, float *alpha_n, float *alpha_t, float *A, int sda, float *x_n…
173 void kernel_sgemv_nt_4_vs_lib8(int kmax, float *alpha_n, float *alpha_t, float *A, int sda, float *…
320 void kernel_sgemv_nt_6_lib4(int kmax, float *alpha_n, float *alpha_t, float *A, int sda, float *x_n…
321 void kernel_sgemv_nt_4_lib4(int kmax, float *alpha_n, float *alpha_t, float *A, int sda, float *x_n…
322 void kernel_sgemv_nt_4_vs_lib4(int kmax, float *alpha_n, float *alpha_t, float *A, int sda, float *…
/dports/multimedia/libv4l/linux-5.13-rc2/drivers/clk/qcom/
H A Dclk-alpha-pll.c683 u32 l, alpha = 0, ctl, alpha_m, alpha_n; in alpha_pll_huayra_recalc_rate() local
711 alpha_n = alpha >> PLL_HUAYRA_N_SHIFT & PLL_HUAYRA_N_MASK; in alpha_pll_huayra_recalc_rate()
718 do_div(tmp, alpha_n); in alpha_pll_huayra_recalc_rate()
722 do_div(tmp, alpha_n); in alpha_pll_huayra_recalc_rate()
/dports/multimedia/v4l-utils/linux-5.13-rc2/drivers/clk/qcom/
H A Dclk-alpha-pll.c683 u32 l, alpha = 0, ctl, alpha_m, alpha_n; in alpha_pll_huayra_recalc_rate() local
711 alpha_n = alpha >> PLL_HUAYRA_N_SHIFT & PLL_HUAYRA_N_MASK; in alpha_pll_huayra_recalc_rate()
718 do_div(tmp, alpha_n); in alpha_pll_huayra_recalc_rate()
722 do_div(tmp, alpha_n); in alpha_pll_huayra_recalc_rate()
/dports/multimedia/v4l_compat/linux-5.13-rc2/drivers/clk/qcom/
H A Dclk-alpha-pll.c683 u32 l, alpha = 0, ctl, alpha_m, alpha_n; in alpha_pll_huayra_recalc_rate() local
711 alpha_n = alpha >> PLL_HUAYRA_N_SHIFT & PLL_HUAYRA_N_MASK; in alpha_pll_huayra_recalc_rate()
718 do_div(tmp, alpha_n); in alpha_pll_huayra_recalc_rate()
722 do_div(tmp, alpha_n); in alpha_pll_huayra_recalc_rate()

123