Home
last modified time | relevance | path

Searched refs:l_max (Results 1 – 25 of 970) sorted by relevance

12345678910>>...39

/dports/math/casadi/casadi-3.5.5/external_packages/casadi-sundials/sundials/
H A Dsundials_spfgmr.c33 if (l_max <= 0) return(NULL); in SpfgmrMalloc()
42 N_VDestroyVectorArray(V, l_max+1); in SpfgmrMalloc()
50 N_VDestroyVectorArray(V, l_max+1); in SpfgmrMalloc()
51 N_VDestroyVectorArray(Z, l_max+1); in SpfgmrMalloc()
54 for (k=0; k<=l_max; k++) { in SpfgmrMalloc()
130 mem->l_max = l_max; in SpfgmrMalloc()
164 l_max = mem->l_max; in SpfgmrSolve()
177 if (maxit > l_max) maxit = l_max; in SpfgmrSolve()
223 for (i=0; i<=l_max; i++) in SpfgmrSolve()
224 for (j=0; j<l_max; j++) in SpfgmrSolve()
[all …]
H A Dsundials_spgmr.c54 if (l_max <= 0) return(NULL); in SpgmrMalloc()
66 N_VDestroyVectorArray(V, l_max+1); in SpgmrMalloc()
70 for (k = 0; k <= l_max; k++) { in SpgmrMalloc()
88 N_VDestroyVectorArray(V, l_max+1); in SpgmrMalloc()
146 mem->l_max = l_max; in SpgmrMalloc()
185 l_max = mem->l_max; in SpgmrSolve()
258 for (i = 0; i <= l_max; i++) in SpgmrSolve()
259 for (j = 0; j < l_max; j++) in SpgmrSolve()
268 for (l = 0; l < l_max; l++) { in SpgmrSolve()
443 int i, l_max; in SpgmrFree() local
[all …]
/dports/science/cp2k/cp2k-2e995eec7fd208c8a72d9544807bd8b8ba8cd1cc/src/eri_mme/
H A Deri_mme_test.F96 ALLOCATE (I_ref(ncoset(l_max), ncoset(l_max), nR, nzet))
110 ALLOCATE (I_test(ncoset(l_max), ncoset(l_max), nR, nzet))
111 ALLOCATE (I_diff(ncoset(l_max), ncoset(l_max), nR, nzet))
114 DO l = 0, l_max
257 ALLOCATE (I_test(ncoset(l_max), ncoset(l_max), ncoset(l_max)))
260 DO la = 0, l_max
261 DO lb = 0, l_max
325 ALLOCATE (C1(0:l_max), H1(0:l_max))
334 ALLOCATE (E_C(-1:l_max + m_max + 1, -1:l_max, -1:m_max))
335 ALLOCATE (E_H(-1:l_max + m_max + 1, -1:l_max, -1:m_max))
[all …]
H A Deri_mme_lattice_summation.F381 DO l = 0, l_max
387 S_G(:) = REAL(S_G_c(0:l_max)*i_pow((/(l, l=0, l_max)/)))*inv_lgth
539 DO l = 0, l_max
547 S_R = MATMUL(TRANSPOSE(h_to_c(0:l_max, 0:l_max)), S_R)*SQRT(alpha/pi)
774 IF (l_max == ${l_max}$) THEN
878 ALLOCATE (E(-1:l_max + m_max + 1, -1:l_max, -1:m_max))
950 E(t, l_max, mm + 1) = zetb*(c1*E(t - 1, l_max, mm) + &
1201 l_max = la_max
1496 DO l = 1, l_max
1688 DIMENSION(-1:l_max + m_max + 1, -1:l_max, -1:m_max) :: E1, E2, E3
[all …]
/dports/science/cp2k-data/cp2k-7.1.0/src/eri_mme/
H A Deri_mme_test.F96 ALLOCATE (I_ref(ncoset(l_max), ncoset(l_max), nR, nzet))
110 ALLOCATE (I_test(ncoset(l_max), ncoset(l_max), nR, nzet))
111 ALLOCATE (I_diff(ncoset(l_max), ncoset(l_max), nR, nzet))
114 DO l = 0, l_max
257 ALLOCATE (I_test(ncoset(l_max), ncoset(l_max), ncoset(l_max)))
260 DO la = 0, l_max
261 DO lb = 0, l_max
325 ALLOCATE (C1(0:l_max), H1(0:l_max))
334 ALLOCATE (E_C(-1:l_max + m_max + 1, -1:l_max, -1:m_max))
335 ALLOCATE (E_H(-1:l_max + m_max + 1, -1:l_max, -1:m_max))
[all …]
H A Deri_mme_lattice_summation.F80 l_max = la_max+lb_max
382 DO l = 0, l_max
388 S_G(:) = REAL(S_G_c(0:l_max)*i_pow((/(l, l=0, l_max)/)))*inv_lgth
541 DO l = 0, l_max
549 S_R = MATMUL(TRANSPOSE(h_to_c(0:l_max, 0:l_max)), S_R)*SQRT(alpha/pi)
866 ALLOCATE (E(-1:l_max+m_max+1, -1:l_max, -1:m_max))
938 E(t, l_max, mm+1) = zetb*(c1*E(t-1, l_max, mm)+ &
1191 l_max = la_max
1486 DO l = 1, l_max
1678 DIMENSION(-1:l_max+m_max+1, -1:l_max, -1:m_max) :: E1, E2, E3
[all …]
/dports/astro/oskar/OSKAR-2.8.0/oskar/math/src/
H A Doskar_spherical_harmonic.c45 dst->l_max = src->l_max; in oskar_spherical_harmonic_copy()
46 if (src->l_max >= 0) in oskar_spherical_harmonic_copy()
51 int location, int l_max, int* status) in oskar_spherical_harmonic_create() argument
55 h->l_max = l_max; in oskar_spherical_harmonic_create()
57 if (l_max >= 0) in oskar_spherical_harmonic_create()
59 const int num_coeff = (l_max + 1) * (l_max + 1); in oskar_spherical_harmonic_create()
75 return h->l_max; in oskar_spherical_harmonic_l_max()
79 int l_max, const oskar_Mem* coeff, int* status) in oskar_spherical_harmonic_set_coeff() argument
81 const int num_coeff = (l_max + 1) * (l_max + 1); in oskar_spherical_harmonic_set_coeff()
87 h->l_max = l_max; in oskar_spherical_harmonic_set_coeff()
H A Doskar_spherical_harmonic_sum.c50 const int l_max = h->l_max; in OSKAR_SPHERICAL_HARMONIC_SUM_REAL() local
52 if (oskar_mem_length(coeff) < (size_t) ((l_max + 1) * (l_max + 1))) in OSKAR_SPHERICAL_HARMONIC_SUM_REAL()
64 oskar_mem_float_const(phi, status), l_max, in OSKAR_SPHERICAL_HARMONIC_SUM_REAL()
74 oskar_mem_double_const(phi, status), l_max, in OSKAR_SPHERICAL_HARMONIC_SUM_REAL()
115 {INT_SZ, &l_max}, in OSKAR_SPHERICAL_HARMONIC_SUM_REAL()
H A Doskar_evaluate_image_lm_grid.c67 float l_max = 0.0f, m_max = 0.0f, *l = 0, *m = 0, r = 0.0f; in oskar_evaluate_image_lm_grid_f() local
74 l_max = sin(0.5 * fov_lon); in oskar_evaluate_image_lm_grid_f()
78 oskar_linspace_f(l, l_max, -l_max, num_l); /* FITS convention. */ in oskar_evaluate_image_lm_grid_f()
110 double l_max = 0.0, m_max = 0.0, *l = 0, *m = 0, r = 0.0; in oskar_evaluate_image_lm_grid_d() local
117 l_max = sin(0.5 * fov_lon); in oskar_evaluate_image_lm_grid_d()
121 oskar_linspace_d(l, l_max, -l_max, num_l); /* FITS convention. */ in oskar_evaluate_image_lm_grid_d()
/dports/science/simbody/simbody-Simbody-3.7/SimTKmath/Integrators/src/CPodes/sundials/src/sundials/
H A Dsundials_spgmr.c49 if (l_max <= 0) return(NULL); in SpgmrMalloc()
61 N_VDestroyVectorArray(V, l_max+1); in SpgmrMalloc()
65 for (k = 0; k <= l_max; k++) { in SpgmrMalloc()
83 N_VDestroyVectorArray(V, l_max+1); in SpgmrMalloc()
141 mem->l_max = l_max; in SpgmrMalloc()
180 l_max = mem->l_max; in SpgmrSolve()
253 for (i = 0; i <= l_max; i++) in SpgmrSolve()
254 for (j = 0; j < l_max; j++) in SpgmrSolve()
263 for (l = 0; l < l_max; l++) { in SpgmrSolve()
438 int i, l_max; in SpgmrFree() local
[all …]
/dports/science/helfem/HelFEM-21461e9/src/legendre/
H A DAssociated_Legendre_Functions.f90753 DO l = int_two, l_max
845 a_lm(2) = l_max + l_max - int_one
857 Leg%I_LM%F(int_zero:l_max,m) = scale_factor * Leg%I_LM%F(int_zero:l_max,m)
873 a_lm(2) = l_max + l_max - int_one
960 ( l_max * ( Leg%R_L%F(l_max) - Leg%R_L%F(l_max-int_one) * cf ) )
961 Leg%I_LM%F(l_max,m) = cf * Leg%I_LM%F(l_max-int_one,m)
965 a_lm(1) = l_max + l_max - int_one
966 a_lm(2) = l_max
987 … Leg%I_LM%F(l_max-int_one,m) = - l_max / ( Leg%R_L%F(l_max) - Leg%R_L%F(l_max-int_one) * cf )
988 Leg%I_LM%F(l_max,m) = cf * Leg%I_LM%F(l_max-int_one,m)
[all …]
H A DAuxilliary_Subroutines.f9075 DO i = int_two, l_max + m_max
106 DO l = m + int_one, l_max
155 nrmlm(0)%leg_fac(0:l_max) = one
163 DO l = m_plus, l_max
173 Write(iout,*) nrmlm(m)%leg_fac(m:l_max)
181 ALLOCATE(nrmlm(m)%norm(m:l_max))
183 DO l = m, l_max
192 Write(iout,*) nrmlm(m)%norm(m:l_max)
216 write(iout,*) 'from l = ',l,' to l =',l_max
217 write(iout,*) nrmlm(l)%leg_fac(0:l_max)
[all …]
H A DLegendre_Wrapper.f9039 l_max = size(Plm,1)-1
42 if(m_max > l_max) l_max=m_max
44 allocate(Leg%R_LM%F(0:l_max,0:m_max))
60 l_max = size(Plm,1)-1
63 if(m_max > l_max) l_max=m_max
65 allocate(Leg%R_LM%F(0:l_max,0:m_max))
81 l_max = size(Qlm,1)-1
82 if(l_max .eq. 0) l_max = 1 ! Libray has problems with l_max=0
85 if(m_max > l_max) l_max=m_max
87 allocate(Leg%I_LM%F(0:l_max,0:m_max))
/dports/science/nwchem/nwchem-7b21660b82ebd85ef659f6fba7e1e73433b0bd0a/src/NWints/ecp/
H A Decp_3j_prod.f33 l_max = l2
38 l_max = l1
43 if (l3 .gt. l_max) then
44 l_mid = l_max
46 l_max = l3
68 wa = 2*l_max+1
74 wa = (2*l_max+1)*(2*l_max-1)
76 wb = (l_max+m_mid)*(l_max-m_mid)
78 wb = (l_max+m_mid)*(l_max+m_mid+1)/2
89 ll_max = 2*l_max
[all …]
H A Decp_init_c2s.F4 subroutine ecp_init_c2s (l_max,tco,lstart,ltr,inorm,itrans, argument
35 & mem_max,ncm,nco,ncp,lstart(0:1,0:l_max)
47 if (DryRun) mem_max = 2*(l_max+1)
48 i_o = 2*l_max+3
50 do l = 0,l_max
60 i_scr = i_o+l_max+2
64 i_scr = i_o+l_max+2
85 do l = 0,l_max-1
98 do l = 0,l_max
108 do l = 2,l_max
[all …]
H A Decp_locint1.F4 subroutine ecp_locint1 (p_min,p_max,l_max,n_prim_a,n_prim_b, argument
47 integer i,ibug,ind_l,ind_p,j,l,l_max, local
55 & Qa(n_ab,0:l_max),Q_int(n_prim_a*n_prim_b,n_int),
71 m_count = l_max/2
73 & m_count,l_max
75 do l = 0,l_max
123 m_hi = l_max-1
130 & l_max,1,n_ab,mm-1,l_max,'Qa before recursion','E',81,5)
134 & l_max,1,n_ab,mm,l_max,'Qa after recursion','E',81,5)
137 do l = mm,l_max
/dports/science/nwchem-data/nwchem-7.0.2-release/src/NWints/ecp/
H A Decp_3j_prod.f33 l_max = l2
38 l_max = l1
43 if (l3 .gt. l_max) then
44 l_mid = l_max
46 l_max = l3
68 wa = 2*l_max+1
74 wa = (2*l_max+1)*(2*l_max-1)
76 wb = (l_max+m_mid)*(l_max-m_mid)
78 wb = (l_max+m_mid)*(l_max+m_mid+1)/2
89 ll_max = 2*l_max
[all …]
H A Decp_init_c2s.F4 subroutine ecp_init_c2s (l_max,tco,lstart,ltr,inorm,itrans, argument
35 & mem_max,ncm,nco,ncp,lstart(0:1,0:l_max)
47 if (DryRun) mem_max = 2*(l_max+1)
48 i_o = 2*l_max+3
50 do l = 0,l_max
60 i_scr = i_o+l_max+2
64 i_scr = i_o+l_max+2
85 do l = 0,l_max-1
98 do l = 0,l_max
108 do l = 2,l_max
[all …]
H A Decp_locint1.F4 subroutine ecp_locint1 (p_min,p_max,l_max,n_prim_a,n_prim_b, argument
47 integer i,ibug,ind_l,ind_p,j,l,l_max, local
55 & Qa(n_ab,0:l_max),Q_int(n_prim_a*n_prim_b,n_int),
71 m_count = l_max/2
73 & m_count,l_max
75 do l = 0,l_max
123 m_hi = l_max-1
130 & l_max,1,n_ab,mm-1,l_max,'Qa before recursion','E',81,5)
134 & l_max,1,n_ab,mm,l_max,'Qa after recursion','E',81,5)
137 do l = mm,l_max
H A Decp_radint1.F4 subroutine ecp_radint1 (p_min,p_max,l_lo,l_min,l_max,m_count, argument
61 integer i,j,ibug,inc_l,ind_l,ind_p,l,ll,lm,l_lo,l_min,l_max, local
69 & Qa(nc_ab,l_lo:l_max,n_cont_c),
86 & l_lo,l_min,l_max
87 do l = l_lo,l_max
170 call ecp_matpr (Qa(1,1,j),1,nc_ab,l_lo,l_max,
171 & 1,nc_ab,l_lo,l_max,'Qa integrals','E',81,5)
180 m_hi = l_max-1
191 & l_max,1,nc_ab,mm-1,l_max,'Qa before recursion','E',81,5)
195 & l_max,1,nc_ab,mm,l_max,'Qa after recursion','E',81,5)
[all …]
/dports/science/chrono/chrono-7.0.1/src/chrono/solver/
H A DChConstraintTwoGenericBoxed.cpp23 : ChConstraintTwoGeneric(mvariables_a, mvariables_b), l_min(-1), l_max(1) {} in CH_FACTORY_REGISTER()
28 l_max = other.l_max; in ChConstraintTwoGenericBoxed()
32 if ((l_i - 10e-5 < l_min) || (l_i + 10e-5 > l_max)) in Violation()
45 l_max = other.l_max; in operator =()
53 if (l_i > l_max) in Project()
54 l_i = l_max; in Project()
60 l_max = mmax; in SetBoxedMinMax()
72 marchive << CHNVP(l_max); in ArchiveOUT()
84 marchive >> CHNVP(l_max); in ArchiveIN()
/dports/science/healpix/Healpix_3.50/src/f90/ngsims_full_sky/
H A Dsky_sub.f9080 Integer(I4B) :: l_max, npw local
94 l_max = nlmax
97 l_max = min(l_max, npw - 1)
99 npw = l_max + 1
101 if (l_max < nlmax) then
102 print*,'C_l are only non-zero for 0 < l <= ',l_max
104 nlmax = l_max
121 If (nlmax .LT. l_max) then
124 l_max = nlmax
157 allocate(beamw(0:l_max,1:1), stat = status)
[all …]
/dports/misc/rump/buildrump.sh-b914579/src/common/lib/libutil/
H A Dsnprintb.c64 size_t l_max) in snprintb_m() argument
97 if (l_max > 0) in snprintb_m()
136 if (l_max > 0 && (size_t)l_len >= l_max) { \ in snprintb_m()
141 if (l_max > 0 && sep != '<') { \ in snprintb_m()
152 if (l_max > 0 && (size_t)l_len >= (l_max - 1)) {\ in snprintb_m()
233 if (l_max > 0 && (size_t)l_len > l_max) in snprintb_m()
264 if (l_max != 0) { in snprintb_m()
/dports/astro/oskar/OSKAR-2.8.0/oskar/telescope/station/element/src/
H A Doskar_element_load_spherical_wave_coeff.c222 const int l_max = (int)round(l_max_d); in oskar_element_load_spherical_wave_coeff() local
223 if (fabs((double)l_max - l_max_d) < FLT_EPSILON) in oskar_element_load_spherical_wave_coeff()
226 if (data->l_max[i] == 0 || data->l_max[i] == l_max) in oskar_element_load_spherical_wave_coeff()
228 data->l_max[i] = l_max; in oskar_element_load_spherical_wave_coeff()
262 l_max, data->l_max[i], filename); in oskar_element_load_spherical_wave_coeff()
271 n, (l_max + 1) * (l_max + 1) - 1, l_max, filename); in oskar_element_load_spherical_wave_coeff()
/dports/astro/oskar/OSKAR-2.8.0/oskar/math/test/
H A DTest_spherical_harmonics.cpp40 static void test_sum(int type, int location, int side_length, int l_max, in test_sum() argument
45 const int num_coeff = (l_max + 1) * (l_max + 1); in test_sum()
54 type, location, l_max, &status); in test_sum()
58 for (int l = 0; l <= l_max; ++l) in test_sum()
66 oskar_spherical_harmonic_set_coeff(sh, l_max, coeff, &status); in test_sum()
113 int l_max = 17; /* Maximum in single precision is 17. */ in TEST() local
148 test_sum(type, location, side, l_max, theta, phi, device.c_str()); in TEST()
166 test_sum(type, location, side, l_max, theta, phi, device.c_str()); in TEST()
169 test_sum(type, OSKAR_CPU, side, l_max, theta, phi, in TEST()

12345678910>>...39