Home
last modified time | relevance | path

Searched refs:omegas (Results 1 – 25 of 135) sorted by relevance

123456

/dports/math/stanmath/math-4.2.0/stan/math/prim/prob/
H A Dhmm_marginal.hpp21 const Eigen::Matrix<T_omega, Eigen::Dynamic, Eigen::Dynamic>& omegas, in hmm_marginal_val() argument
26 const int n_states = omegas.rows(); in hmm_marginal_val()
27 const int n_transitions = omegas.cols() - 1; in hmm_marginal_val()
28 alphas.col(0) = omegas.col(0).cwiseProduct(rho_val); in hmm_marginal_val()
103 eig_matrix_partial omegas = value_of(log_omegas_ref).array().exp(); in hmm_marginal() local
106 omegas, Gamma_val, rho_val, alphas, alpha_log_norms, norm_norm); in hmm_marginal()
135 * kappa[n].cwiseProduct(omegas.col(n + 1)).transpose() in hmm_marginal()
145 = omegas.cwiseProduct(rho_val) / exp(log_marginal_density); in hmm_marginal()
150 = omegas.col(0) / exp(log_marginal_density); in hmm_marginal()
169 = log_omega_jacad.cwiseProduct(omegas / unnormed_marginal); in hmm_marginal()
[all …]
H A Dhmm_latent_rng.hpp50 Eigen::MatrixXd omegas = value_of(log_omegas).array().exp(); in hmm_latent_rng() local
56 alphas.col(0) = omegas.col(0).cwiseProduct(rho_dbl); in hmm_latent_rng()
61 = omegas.col(n + 1).cwiseProduct(Gamma_dbl.transpose() * alphas.col(n)); in hmm_latent_rng()
81 * beta(last_hs) * omegas(last_hs, n + 1); in hmm_latent_rng()
91 beta = Gamma_dbl * (omegas.col(n + 1).cwiseProduct(beta)); in hmm_latent_rng()
H A Dhmm_hidden_state_prob.hpp54 Eigen::MatrixXd omegas = value_of(log_omegas).array().exp(); in hmm_hidden_state_prob() local
60 alphas.col(0) = omegas.col(0).cwiseProduct(rho_dbl); in hmm_hidden_state_prob()
65 = omegas.col(n + 1).cwiseProduct(Gamma_dbl.transpose() * alphas.col(n)); in hmm_hidden_state_prob()
73 beta = Gamma_dbl * omegas.col(n + 1).cwiseProduct(beta); in hmm_hidden_state_prob()
/dports/biology/gmap/gmap-2020-09-12/src/
H A Diit-write-univ.c117 assert(is_empty (omegas, i, j)); in is_valid_input()
209 omegas[q] = sigmas[lambda]; in Node_make()
227 sigmas[lambda] = omegas[lambda]; in Node_make()
229 Univinterval_qsort_by_omega(omegas,q+1,r,intervals); in Node_make()
267 int *omegas; in IIT_count_nnodes() local
287 omegas = (int *) CALLOC(nintervals+1,sizeof(int)); in IIT_count_nnodes()
293 FREE(omegas); in IIT_count_nnodes()
329 *omegas = (int *) CALLOC(nintervals+1,sizeof(int)); in IIT_build_univ()
634 int *sigmas, *omegas; in IIT_write_univ() local
669 FWRITE_INTS(omegas,total_nintervals + 1,fp); in IIT_write_univ()
[all …]
H A Diit-write.c127 assert(is_empty (omegas, i, j)); in is_valid_input()
220 omegas[q] = sigmas[lambda]; in Node_make()
238 sigmas[lambda] = omegas[lambda]; in Node_make()
280 int *omegas; in IIT_count_nnodes() local
306 FREE(omegas); in IIT_count_nnodes()
819 FWRITE_INTS(omegas,nintervals + 1,fp); in IIT_write_one_div()
830 printf(" %d",omegas[i]); in IIT_write_one_div()
865 new->omegas[divno][i] = omegas[i]; in IIT_create_one_div()
1476 int *alphas, *betas, *sigmas, *omegas; in IIT_write() local
1536 FREE(omegas); in IIT_write()
[all …]
/dports/science/py-pyscf/pyscf-2.0.1/doc_legacy/source/nao/examples/
H A Dcalc_polarizability.py16 omegas = np.arange(2.0, 8.0, 2.5E-3)/Ha + 1j*td.eps
18 pxx = -td.comp_polariz_nonin_ave(omegas)
22 data = np.zeros((omegas.shape[0], 3))
23 data[:, 0] = omegas.real*Ha
29 pxx = -td.comp_polariz_inter_ave(omegas)
32 data = np.zeros((omegas.shape[0], 3))
33 data[:, 0] = omegas.real*Ha
/dports/science/py-phonopy/phonopy-2.11.0/phonopy/structure/
H A Dtetrahedron_method.py84 def get_tetrahedra_integration_weight(omegas, argument
102 if isinstance(omegas, float):
104 omegas,
111 np.array(omegas, dtype='double'),
140 def run(self, omegas, value='I'): argument
142 self._run_c(omegas, value=value)
144 self._run_py(omegas, value=value)
173 def _run_c(self, omegas, value='I'): argument
175 omegas,
179 def _run_py(self, omegas, value='I'): argument
[all …]
/dports/science/phonopy/phonopy-2.11.0/phonopy/structure/
H A Dtetrahedron_method.py84 def get_tetrahedra_integration_weight(omegas, argument
102 if isinstance(omegas, float):
104 omegas,
111 np.array(omegas, dtype='double'),
140 def run(self, omegas, value='I'): argument
142 self._run_c(omegas, value=value)
144 self._run_py(omegas, value=value)
173 def _run_c(self, omegas, value='I'): argument
175 omegas,
179 def _run_py(self, omegas, value='I'): argument
[all …]
/dports/science/ascent/ascent-0.7.1-66-gbcf2742a/src/examples/proxies/kripke/Kripke/
H A DDirections.cpp157 double omegas[3]; in InitDirections() local
158 omegas[0] = octant & 0x1; in InitDirections()
159 omegas[1] = (octant>>1) & 0x1; in InitDirections()
160 omegas[2] = (octant>>2) & 0x1; in InitDirections()
164 directions[d].id = (omegas[0] > 0.) ? 1 : -1; in InitDirections()
165 directions[d].jd = (omegas[1] > 0.) ? 1 : -1; in InitDirections()
166 directions[d].kd = (omegas[2] > 0.) ? 1 : -1; in InitDirections()
/dports/math/gfan/gfan0.6.2/src/
H A Dapp_integergb.cpp102 IntegerVectorList omegas; in main() local
104 omegas=P.parseIntegerVectorList(); in main()
106 omegas.push_back(P.parseIntegerVector()); in main()
108 for(IntegerVectorList::const_iterator i=omegas.begin();i!=omegas.end();i++) in main()
H A Dapp_padic.cpp116 IntegerVectorList omegas; in main() local
118 omegas=P.parseIntegerVectorList(); in main()
120 omegas.push_back(P.parseIntegerVector()); in main()
122 for(IntegerVectorList::const_iterator i=omegas.begin();i!=omegas.end();i++) in main()
/dports/math/gfanlib/gfan0.6.2/src/
H A Dapp_integergb.cpp102 IntegerVectorList omegas; in main() local
104 omegas=P.parseIntegerVectorList(); in main()
106 omegas.push_back(P.parseIntegerVector()); in main()
108 for(IntegerVectorList::const_iterator i=omegas.begin();i!=omegas.end();i++) in main()
H A Dapp_padic.cpp116 IntegerVectorList omegas; in main() local
118 omegas=P.parseIntegerVectorList(); in main()
120 omegas.push_back(P.parseIntegerVector()); in main()
122 for(IntegerVectorList::const_iterator i=omegas.begin();i!=omegas.end();i++) in main()
/dports/biology/hyphy/hyphy-2.5.33/res/TemplateBatchFiles/SelectionAnalyses/
H A DRELAX-Groups.bf221 relax.getRateInformation.rate_classes = Abs (model_description["omegas"]);
284 model_parameters["omegas"] = parameters.GenerateSequentialNames ("`id`.omega", 3, "_");
290 parameters.DeclareGlobal (model_parameters["omegas"], None);
297 parameters.SetRange ((model_parameters["omegas"])[0], terms.range_almost_01);
298 parameters.SetValue ((model_parameters["omegas"])[0], relax.init_omegas[0]);
300 parameters.SetRange ((model_parameters["omegas"])[1], terms.range_almost_01);
301 parameters.SetValue ((model_parameters["omegas"])[1], relax.init_omegas[1]);
303 parameters.SetRange ((model_parameters["omegas"])[2], terms.range_gte1);
304 parameters.SetValue ((model_parameters["omegas"])[2], relax.init_omegas[2]);
307 …Constraint ((model_parameters["omegas"])[2], " 1/" + ((model_parameters["omegas"])[0]) + "/" + ((m…
[all …]
/dports/math/py-networkx/networkx-2.6.3/networkx/algorithms/tests/
H A Dtest_smallworld.py58 omegas = omega(Gs, niter=1, nrand=1, seed=rng)
60 print(omegas, omegal, omegar)
61 assert omegal < omegas and omegas < omegar
/dports/science/py-spglib/spglib-1.16.2/example/
H A Dtetrahedron.c77 double omegas[num_freqs]; in test_tetrahedron_method() local
145 omegas[i] = min_f + (max_f - min_f) / (num_freqs - 1) * i; in test_tetrahedron_method()
158 iw = thm_get_integration_weight(omegas[i], t_omegas, 'J'); in test_tetrahedron_method()
160 iw = thm_get_integration_weight(omegas[i], t_omegas, 'I'); in test_tetrahedron_method()
169 fprintf(fp, "%f %f\n", omegas[i], dos[i] / num_gp); in test_tetrahedron_method()
175 fprintf(fp, "%f %f\n", omegas[i], integral_dos[i] / num_gp); in test_tetrahedron_method()
/dports/science/octopus/octopus-10.5/external_libs/spglib-1.9.9/example/
H A Dtetrahedron.c77 double omegas[num_freqs]; in test_tetrahedron_method() local
145 omegas[i] = min_f + (max_f - min_f) / (num_freqs - 1) * i; in test_tetrahedron_method()
158 iw = thm_get_integration_weight(omegas[i], t_omegas, 'J'); in test_tetrahedron_method()
160 iw = thm_get_integration_weight(omegas[i], t_omegas, 'I'); in test_tetrahedron_method()
169 fprintf(fp, "%f %f\n", omegas[i], dos[i] / num_gp); in test_tetrahedron_method()
175 fprintf(fp, "%f %f\n", omegas[i], integral_dos[i] / num_gp); in test_tetrahedron_method()
/dports/science/spglib/spglib-1.16.2/example/
H A Dtetrahedron.c77 double omegas[num_freqs]; in test_tetrahedron_method() local
145 omegas[i] = min_f + (max_f - min_f) / (num_freqs - 1) * i; in test_tetrahedron_method()
158 iw = thm_get_integration_weight(omegas[i], t_omegas, 'J'); in test_tetrahedron_method()
160 iw = thm_get_integration_weight(omegas[i], t_omegas, 'I'); in test_tetrahedron_method()
169 fprintf(fp, "%f %f\n", omegas[i], dos[i] / num_gp); in test_tetrahedron_method()
175 fprintf(fp, "%f %f\n", omegas[i], integral_dos[i] / num_gp); in test_tetrahedron_method()
/dports/math/gismo/gismo-21.12.0/extensions/gsKLShell/examples/
H A Dunittest_modal.cpp170 std::vector<real_t> omegas; in analytical() local
173omegas.push_back((math::pow(m/1.0,2)+math::pow(n/1.0,2))*math::pow(3.1415926535,2)*math::sqrt(D / … in analytical()
175 std::sort(omegas.begin(),omegas.end()); in analytical()
176 omegas.resize(10); in analytical()
177 gsAsVector<> analytical(omegas); in analytical()
/dports/math/gismo/gismo-21.12.0/extensions/gsStructuralAnalysis/examples/
H A DgsThinShell_Modal.cpp178 std::vector<real_t> omegas; in main() local
198 omegas.push_back(math::pow((n*3.1415926535/length),2)*math::pow(EI/(Density*Area),0.5)); in main()
220 omegas.push_back(math::pow((4.73004/length),2)*math::pow(EI/(Density*Area),0.5)); in main()
240omegas.push_back(3.52/(2*3.1415926535)*math::pow((1/length),2)*math::pow(EI/(Density*Area),0.5)); in main()
257 omegas.push_back(0.0); in main()
291 std::sort(omegas.begin(),omegas.end()); in main()
334 omegas.push_back(0); in main()
363 omegas.push_back(0); in main()
400 omegas.push_back(math::pow(math::pow(gammas[n],4)*D/(Density*thickness),0.5)); in main()
421 omegas.push_back(0); in main()
[all …]
/dports/science/dalton/dalton-66052b3af5ea7225e31178bf9a8b031913c72190/DALTON/include/
H A Dccexcinf.h12 * OMEINP : flag that omegas for triples calculations have been
14 * NOMINP : # omegas given
16 * EOMINP : omegas...
/dports/science/lammps/lammps-stable_29Sep2021/examples/PACKAGES/phonon/dynamical_matrix_command/python/
H A Ddynmat.py41 omegas = np.sqrt(np.abs(eigvals))/2/np.pi variable
42 print(omegas)
/dports/science/quantum-espresso/q-e-qe-6.7.0/GWW/gww/
H A Dfit_multipole.f90419 REAL(kind=DP) :: omegas(m) local
423 freq(1:m)=omegas(1:m)
532 REAL(kind=DP), ALLOCATABLE :: omegas(:) local
538 allocate(omegas(n))
540 omegas(1:n)=aimag(z(1:n))
563 call fcn_set(n, m, omegas,s)
658 REAL(kind=DP), ALLOCATABLE :: omegas(:) local
673 allocate(omegas(n))
686 omegas(1:n)=aimag(z(1:n))
714 call fcn_set(n, m, omegas,s)
[all …]
/dports/cad/py-lcapy/lcapy-23c940f/demo/twoport/
H A Dloudspeaker2.py17 omegas = 2 * np.pi * fs variable
18 Rms = Qms / (omegas * Cms)
/dports/astro/py-jplephem/python-jplephem-2.17/jplephem/
H A Dephem.py155 omegas = (index == number_of_sets)
156 index[omegas] -= 1
157 offset[omegas] += days_per_set

123456