Home
last modified time | relevance | path

Searched refs:N_max (Results 1 – 25 of 51) sorted by relevance

123

/dports/lang/gnu-apl/apl-1.8/src/
H A DMacro.def25 "N←⎕IO ◊ N_max←N+⍴B←,B\n"
32 "N←⎕IO ◊ N_max←N+⍴B←,B\n"
39 "N←⎕IO ◊ N_max←N+⍴A←,A\n"
53 "rho_Z←⍴B ◊ N←⎕IO ◊ N_max←N+⍴B←,B ◊ Z←N_max⍴0\n"
68 "rho_Z←⍴B ◊ N←⎕IO ◊ N_max←N+⍴B←,B ◊ Z←N_max⍴0\n"
76 "rho_Z←⍴A ◊ N←⎕IO ◊ N_max←N+⍴A←,A ◊ Z←N_max⍴0\n"
84 "rho_Z←⍴B ◊ N←⎕IO ◊ A←,A ◊ N_max←N+⍴B←,B ◊ Z←N_max⍴0\n"
92 "rho_Z←(⍴A),⍴B ◊ N←⎕IO ◊ A←,A ◊ B←,B ◊ I←,⍳(⍴A),⍴B ◊ N_max←N+⍴I ◊ Z←N_max⍴0\n"
102 "I←,⍳rho_Z←r_Ah, r_Bl ◊ N←⎕IO ◊ N_max←N+⍴I ◊ Z←N_max⍴0\n"
199 " N_max←LZ+N←⎕IO ◊ Z←LZ⍴0\n"
[all …]
/dports/math/gsl/gsl-2.7/linalg/
H A Dtest_lu_band.c80 const size_t N_max = 20; in test_LU_band_decomp() local
81 gsl_matrix * A = gsl_matrix_alloc(N_max, N_max); in test_LU_band_decomp()
84 for (M = 1; M <= N_max; ++M) in test_LU_band_decomp()
86 for (N = 1; N <= N_max; ++N) in test_LU_band_decomp()
149 const size_t N_max = 20; in test_LU_band_solve() local
150 gsl_matrix * A = gsl_matrix_alloc(N_max, N_max); in test_LU_band_solve()
151 gsl_vector * b = gsl_vector_alloc(N_max); in test_LU_band_solve()
152 gsl_vector * x = gsl_vector_alloc(N_max); in test_LU_band_solve()
155 for (N = 1; N <= N_max; ++N) in test_LU_band_solve()
H A Dtest_qr.c614 gsl_matrix * U1 = gsl_matrix_alloc(N_max, N_max); in test_QR_UZ_decomp()
615 gsl_matrix * U2 = gsl_matrix_alloc(N_max, N_max); in test_QR_UZ_decomp()
724 gsl_matrix * U = gsl_matrix_alloc(N_max, N_max); in test_QR_UU_decomp()
725 gsl_matrix * S = gsl_matrix_alloc(N_max, N_max); in test_QR_UU_decomp()
726 gsl_matrix * T = gsl_matrix_alloc(N_max, N_max); in test_QR_UU_decomp()
841 gsl_matrix * U = gsl_matrix_alloc(N_max, N_max); in test_QR_UU_lssolve()
842 gsl_matrix * S = gsl_matrix_alloc(N_max, N_max); in test_QR_UU_lssolve()
843 gsl_matrix * T = gsl_matrix_alloc(N_max, N_max); in test_QR_UU_lssolve()
946 gsl_matrix * U = gsl_matrix_alloc(N_max, N_max); in test_QR_UD_decomp()
947 gsl_matrix * S = gsl_matrix_alloc(N_max, N_max); in test_QR_UD_decomp()
[all …]
H A Dtest_cholesky.c156 const size_t N_max = 200; in test_cholesky_decomp() local
227 const size_t N_max = 200; in test_cholesky_invert() local
409 const size_t N_max = 50; in test_mcholesky_decomp() local
477 const size_t N_max = 50; in test_mcholesky_solve() local
554 const size_t N_max = 30; in test_mcholesky_invert() local
717 const size_t N_max = 50; in test_pcholesky_decomp() local
794 const size_t N_max = 50; in test_pcholesky_solve() local
871 const size_t N_max = 200; in test_pcholesky_invert() local
964 const size_t N_max = 50; in test_cholesky_band_decomp() local
1038 const size_t N_max = 50; in test_cholesky_band_solve() local
[all …]
H A Dtest_ldlt.c120 const size_t N_max = 50; in test_ldlt_decomp() local
123 for (N = 1; N <= N_max; ++N) in test_ldlt_decomp()
183 const size_t N_max = 50; in test_ldlt_solve() local
186 for (N = 1; N <= N_max; ++N) in test_ldlt_solve()
294 const size_t N_max = 50; in test_ldlt_band_decomp() local
297 for (N = 1; N <= N_max; ++N) in test_ldlt_band_decomp()
348 const size_t N_max = 50; in test_ldlt_band_solve() local
351 for (N = 1; N <= N_max; ++N) in test_ldlt_band_solve()
H A Dtest_choleskyc.c104 const size_t N_max = 50; in test_choleskyc_decomp() local
107 for (N = 1; N <= N_max; ++N) in test_choleskyc_decomp()
166 const size_t N_max = 50; in test_choleskyc_invert() local
169 for (N = 1; N <= N_max; ++N) in test_choleskyc_invert()
H A Dtest_qr_band.c91 const size_t N_max = 20; in test_QR_band_decomp() local
95 for (M = 1; M <= N_max; ++M) in test_QR_band_decomp()
97 for (N = 1; N <= N_max; ++N) in test_QR_band_decomp()
/dports/math/nfft/nfft-3.5.2/matlab/fpt/
H A Dsimple_test.m29 N_max = 2^t; % maximal polynomial degree variable
30 k_end = N_max;
36 % desired (2^t), i.e., t = 3 means that N_max in (1) can be at most N = 8.
43 % Note that the length of these vectors has to be N_max+2
44 alpha = [0 ((2*(0:N_max)+1)./((0:N_max)+1))]';
45 beta = zeros(N_max+2,1);
46 gamma = [1 -((0:N_max)./((0:N_max)+1))]';
56 % random Fourier coefficients of the length at most N_max
82 alpha_chebyshev = [0 1 repmat(2,1,N_max)]';
83 beta_chebyshev = zeros(N_max+2,1);
[all …]
/dports/astro/pykep/pykep-2.6/pykep/trajopt/
H A D_pl2pl_N_impulses.py28 N_max=3, argument
55 if N_max < 2:
71 self.N_max = N_max
81 vinf[0] * 1000] * (N_max - 2) + [1e-3] + [0]
83 … 1] * 1000] * (N_max - 2) + [1.0-1e-3] + [2 * target.compute_period(epoch(0)) * SEC2DAY]
86 [1e-3, 0.0, 0.0, vinf[0] * 1000] * (N_max - 2) + [1e-3]
88 [1.0-1e-3, 1.0, 1.0, vinf[1] * 1000] * (N_max - 2) + [1.0-1e-3]
99 T = list([0] * (self.N_max - 1))
174 T = list([0] * (self.N_max - 1))
237 T = list([0] * (self.N_max - 1))
/dports/astro/py-pykep/pykep-2.6/pykep/trajopt/
H A D_pl2pl_N_impulses.py28 N_max=3, argument
55 if N_max < 2:
71 self.N_max = N_max
81 vinf[0] * 1000] * (N_max - 2) + [1e-3] + [0]
83 … 1] * 1000] * (N_max - 2) + [1.0-1e-3] + [2 * target.compute_period(epoch(0)) * SEC2DAY]
86 [1e-3, 0.0, 0.0, vinf[0] * 1000] * (N_max - 2) + [1e-3]
88 [1.0-1e-3, 1.0, 1.0, vinf[1] * 1000] * (N_max - 2) + [1.0-1e-3]
99 T = list([0] * (self.N_max - 1))
174 T = list([0] * (self.N_max - 1))
237 T = list([0] * (self.N_max - 1))
/dports/math/adol-c/ADOL-C-2.7.2/ADOL-C/src/
H A Dfixpoint.cpp40 int N_max; member
54 for (k=1; k<=current->N_max; k++) { in iteration()
84 for (k=1; k<=current->N_max; k++) { in fp_zos_forward()
114 for (k=1; (k<current->N_max_deriv)|(k<current->N_max); k++) { in fp_fos_forward()
182 int N_max, in fp_iteration() argument
200 data->N_max = N_max; in fp_iteration()
/dports/math/armadillo/armadillo-10.7.1/include/armadillo_bits/
H A Dop_nonzeros_meat.hpp34 const uword N_max = P.get_n_elem(); in apply_noalias() local
36 Mat<eT> tmp(N_max, 1, arma_nozeros_indicator()); in apply_noalias()
46 for(uword i=0; i<N_max; ++i) in apply_noalias()
/dports/math/R-cran-RcppArmadillo/RcppArmadillo/inst/include/armadillo_bits/
H A Dop_nonzeros_meat.hpp34 const uword N_max = P.get_n_elem(); in apply_noalias() local
36 Mat<eT> tmp(N_max, 1, arma_nozeros_indicator()); in apply_noalias()
46 for(uword i=0; i<N_max; ++i) in apply_noalias()
/dports/math/gsl/gsl-2.7/spblas/
H A Dtest.c235 const size_t N_max = 40; in main() local
239 for (m = 1; m <= N_max; ++m) in main()
241 for (n = 1; n <= N_max; ++n) in main()
/dports/math/gsl/gsl-2.7/eigen/
H A Dtest.c388 size_t N_max = 20; in test_eigen_symm() local
392 for (n = 1; n <= N_max; ++n) in test_eigen_symm()
586 size_t N_max = 20; in test_eigen_herm() local
590 for (n = 1; n <= N_max; ++n) in test_eigen_herm()
738 size_t N_max = 20; in test_eigen_nonsymm() local
742 for (n = 1; n <= N_max; ++n) in test_eigen_nonsymm()
848 size_t N_max = 50; in test_eigen_gensymm() local
852 for (n = 1; n <= N_max; ++n) in test_eigen_gensymm()
978 size_t N_max = 50; in test_eigen_genherm() local
982 for (n = 1; n <= N_max; ++n) in test_eigen_genherm()
[all …]
/dports/multimedia/mjpegtools/mjpegtools-2.1.0/mpeg2enc/
H A Dstreamstate.cc101 return nc_distance <= (nc_distance/encparams.N_min) * encparams.N_max; in CanSplitHere()
260 for( gop_length = encparams.N_max; gop_length > encparams.N_min; gop_length-- ) in GopStart()
H A Dencoderparams.cc191 N_max = options.max_GOP_size; in Init()
194 N_min, N_max, in Init()
199 if( M > N_max ) in Init()
200 M = N_max; in Init()
H A Dencoderparams.hh225 unsigned int N_max; /* number of frames in Group of Pictures (max) */ member in EncoderParams
/dports/math/adol-c/ADOL-C-2.7.2/ADOL-C/include/adolc/
H A Dfixpoint.h30 int N_max,
/dports/astro/pykep/pykep-2.6/pykep/trajopt/gym/
H A D_emNimp.py16 N_max=N,
/dports/astro/py-pykep/pykep-2.6/pykep/trajopt/gym/
H A D_emNimp.py16 N_max=N,
/dports/astro/pykep/pykep-2.6/pykep/examples/
H A D_ex1.py12 N_max=impulses,
/dports/astro/py-pykep/pykep-2.6/pykep/examples/
H A D_ex1.py12 N_max=impulses,
/dports/science/cp2k/cp2k-2e995eec7fd208c8a72d9544807bd8b8ba8cd1cc/src/
H A Dfermi_utils.F213 N_max, N_min, N_now local
242 CALL Fermi(f, N_max, kTS, e, mu_max, T, maxocc, my_estate, my_festate)
243 IF (N_max < N .OR. iter > 20) THEN
/dports/science/cp2k-data/cp2k-7.1.0/src/
H A Dfermi_utils.F213 N_max, N_min, N_now local
242 CALL Fermi(f, N_max, kTS, e, mu_max, T, maxocc, my_estate, my_festate)
243 IF (N_max < N .OR. iter > 20) THEN

123