Changeset cedad32 in sasmodels


Ignore:
Timestamp:
Mar 20, 2016 4:43:56 AM (8 years ago)
Author:
smk78
Branches:
master, core_shell_microgels, costrafo411, magnetic_model, release_v0.94, release_v0.95, ticket-1257-vesicle-product, ticket_1156, ticket_1265_superball, ticket_822_more_unit_tests
Children:
2f63032
Parents:
0a7eec11 (diff), bad8b12 (diff)
Note: this is a merge changeset, the changes displayed below correspond to the merge itself.
Use the (diff) links above to see all the changes relative to each parent.
Message:

Merge branch 'master' of https://github.com/SasView/sasmodels

Files:
3 added
3 deleted
31 edited

Legend:

Unmodified
Added
Removed
  • doc/genmodel.py

    r824465b r89f4163  
    3333    'qx_max'    : 0.5, 
    3434    #'colormap'  : 'gist_ncar', 
    35     'colormap'  : 'jet', 
     35    'colormap'  : 'nipy_spectral', 
     36    #'colormap'  : 'jet', 
    3637} 
    3738 
  • sasmodels/convert.py

    r12dbc90 rbad8b12  
    1717    'fractal_core_shell', 
    1818    'binary_hard_sphere', 
     19    'raspberry' 
    1920] 
    2021 
  • sasmodels/models/barbell.c

    r50e1e40 r26141cb  
    3131        const double t = Gauss76Z[i]*zm + zb; 
    3232        const double radical = 1.0 - t*t; 
    33         const double bj = J1c(qrst*sqrt(radical)); 
     33        const double bj = sas_J1c(qrst*sqrt(radical)); 
    3434        const double Fq = cos(m*t + b) * radical * bj; 
    3535        total += Gauss76Wt[i] * Fq; 
     
    7373 
    7474        const double bell_Fq = _bell_kernel(q, h, bell_radius, half_length, sin_alpha, cos_alpha); 
    75         const double bj = J1c(q*radius*sin_alpha); 
     75        const double bj = sas_J1c(q*radius*sin_alpha); 
    7676        const double si = sinc(q*half_length*cos_alpha); 
    7777        const double cyl_Fq = M_PI*radius*radius*length*bj*si; 
     
    108108    SINCOS(alpha, sin_alpha, cos_alpha); 
    109109    const double bell_Fq = _bell_kernel(q, h, bell_radius, half_length, sin_alpha, cos_alpha); 
    110     const double bj = J1c(q*radius*sin_alpha); 
     110    const double bj = sas_J1c(q*radius*sin_alpha); 
    111111    const double si = sinc(q*half_length*cos_alpha); 
    112112    const double cyl_Fq = M_PI*radius*radius*length*bj*si; 
  • sasmodels/models/barbell.py

    r2f0c07d r26141cb  
    111111# pylint: enable=bad-whitespace, line-too-long 
    112112 
    113 source = ["lib/J1c.c", "lib/gauss76.c", "barbell.c"] 
     113source = ["lib/polevl.c", "lib/sas_J1.c", "lib/gauss76.c", "barbell.c"] 
    114114 
    115115# parameters for demo 
  • sasmodels/models/bcc.py

    r2f0c07d r43b7eea  
    124124# pylint: enable=bad-whitespace, line-too-long 
    125125 
    126 source = ["lib/sph_j1c.c", "lib/J1.c", "lib/gauss150.c", "lib/sphere_form.c", "bcc.c"] 
     126source = ["lib/sph_j1c.c", "lib/gauss150.c", "lib/sphere_form.c", "bcc.c"] 
    127127 
    128128# parameters for demo 
  • sasmodels/models/capped_cylinder.c

    r50e1e40 r26141cb  
    3737        const double t = Gauss76Z[i]*zm + zb; 
    3838        const double radical = 1.0 - t*t; 
    39         const double bj = J1c(qrst*sqrt(radical)); 
     39        const double bj = sas_J1c(qrst*sqrt(radical)); 
    4040        const double Fq = cos(m*t + b) * radical * bj; 
    4141        total += Gauss76Wt[i] * Fq; 
     
    9494 
    9595        const double cap_Fq = _cap_kernel(q, h, cap_radius, half_length, sin_alpha, cos_alpha); 
    96         const double bj = J1c(q*radius*sin_alpha); 
     96        const double bj = sas_J1c(q*radius*sin_alpha); 
    9797        const double si = sinc(q*half_length*cos_alpha); 
    9898        const double cyl_Fq = M_PI*radius*radius*length*bj*si; 
     
    129129    SINCOS(alpha, sin_alpha, cos_alpha); 
    130130    const double cap_Fq = _cap_kernel(q, h, cap_radius, half_length, sin_alpha, cos_alpha); 
    131     const double bj = J1c(q*radius*sin_alpha); 
     131    const double bj = sas_J1c(q*radius*sin_alpha); 
    132132    const double si = sinc(q*half_length*cos_alpha); 
    133133    const double cyl_Fq = M_PI*radius*radius*length*bj*si; 
  • sasmodels/models/capped_cylinder.py

    r2f0c07d raa24114  
    33Like :ref:`barbell`, this is a sphereocylinder with end caps that have a 
    44radius larger than that of the cylinder, but with the center of the end cap 
    5 radius lying within the cylinder. This model simply becomes the a convex 
     5radius lying within the cylinder. This model simply becomes a convex 
    66lens when the length of the cylinder $L=0$. See the diagram for the details 
    77of the geometry and restrictions on parameter values. 
     
    9595    end cap radius lies within the cylinder. 
    9696    Note: As the length of cylinder -->0, 
    97     it becomes a ConvexLens. 
     97    it becomes a Convex Lens. 
    9898    It must be that radius <(=) cap_radius. 
    9999    [Parameters]; 
     
    104104    cap_radius: radius of the semi-spherical cap, 
    105105    sld: SLD of the capped cylinder, 
    106     solvent_sld: SLD of the solvent. 
     106    sld_solvent: SLD of the solvent. 
    107107""" 
    108108category = "shape:cylinder" 
     
    110110#             ["name", "units", default, [lower, upper], "type", "description"], 
    111111parameters = [["sld",         "1e-6/Ang^2", 4, [-inf, inf], "",       "Cylinder scattering length density"], 
    112               ["solvent_sld", "1e-6/Ang^2", 1, [-inf, inf], "",       "Solvent scattering length density"], 
     112              ["sld_solvent", "1e-6/Ang^2", 1, [-inf, inf], "",       "Solvent scattering length density"], 
    113113              ["radius",      "Ang",       20, [0, inf],    "volume", "Cylinder radius"], 
    114114 
     
    129129# pylint: enable=bad-whitespace, line-too-long 
    130130 
    131 source = ["lib/J1c.c", "lib/gauss76.c", "capped_cylinder.c"] 
     131source = ["lib/polevl.c", "lib/sas_J1.c", "lib/gauss76.c", "capped_cylinder.c"] 
    132132 
    133133demo = dict(scale=1, background=0, 
    134             sld=6, solvent_sld=1, 
     134            sld=6, sld_solvent=1, 
    135135            radius=260, cap_radius=290, length=290, 
    136136            theta=30, phi=15, 
     
    142142oldname = 'CappedCylinderModel' 
    143143oldpars = dict(sld='sld_capcyl', 
    144                solvent_sld='sld_solv', 
     144               sld_solvent='sld_solv', 
    145145               length='len_cyl', 
    146146               radius='rad_cyl', 
  • sasmodels/models/core_shell_bicelle.c

    rcf85329 r43b7eea  
    5656    double sinarg2 = qq*(length+facthick)*cn; 
    5757 
    58     be1 = J1c(besarg1); 
    59     be2 = J1c(besarg2); 
     58    be1 = sas_J1c(besarg1); 
     59    be2 = sas_J1c(besarg2); 
    6060    si1 = sinc(sinarg1); 
    6161    si2 = sinc(sinarg2); 
  • sasmodels/models/core_shell_bicelle.py

    r2f0c07d r43b7eea  
    8787# pylint: enable=bad-whitespace, line-too-long 
    8888 
    89 source = ["lib/Si.c", "lib/J1.c", "lib/J1c.c", "lib/gauss76.c", "core_shell_bicelle.c"] 
     89source = ["lib/Si.c","lib/polevl.c", "lib/sas_J1.c", "lib/gauss76.c", "core_shell_bicelle.c"] 
    9090 
    9191demo = dict(scale=1, background=0, 
  • sasmodels/models/core_shell_cylinder.c

    rf4878dc r43b7eea  
    1111double _cyl(double twovd, double besarg, double siarg) 
    1212{ 
    13     const double bj = (besarg == 0.0 ? 0.5 : J1(besarg)/besarg); 
     13    const double bj = (besarg == 0.0 ? 0.5 : 0.5*sas_J1c(besarg)); 
    1414    const double si = (siarg == 0.0 ? 1.0 : sin(siarg)/siarg); 
    1515    return twovd*si*bj; 
  • sasmodels/models/core_shell_cylinder.py

    r01eece6 r43b7eea  
    130130             ] 
    131131 
    132 source = ["lib/J1.c", "lib/gauss76.c", "core_shell_cylinder.c"] 
     132source = ["lib/polevl.c","lib/sas_J1.c", "lib/gauss76.c", "core_shell_cylinder.c"] 
    133133 
    134134def ER(radius, thickness, length): 
  • sasmodels/models/core_shell_parallelepiped.py

    raa2edb2 r43b7eea  
    141141             ] 
    142142 
    143 source = ["lib/J1.c", "lib/gauss76.c", "core_shell_parallelepiped.c"] 
     143source = ["lib/gauss76.c", "core_shell_parallelepiped.c"] 
    144144 
    145145 
  • sasmodels/models/cylinder.c

    r50e1e40 r26141cb  
    2929        double sn, cn; 
    3030        SINCOS(alpha, sn, cn); 
    31         const double fq = sinc(qh*cn) * J1c(qr*sn); 
     31        const double fq = sinc(qh*cn) * sas_J1c(qr*sn); 
    3232        total += Gauss76Wt[i] * fq*fq * sn; 
    3333    } 
     
    5757 
    5858    SINCOS(alpha, sn, cn); 
    59     const double fq = sinc(q*0.5*length*cn) * J1c(q*radius*sn); 
     59    const double fq = sinc(q*0.5*length*cn) * sas_J1c(q*radius*sn); 
    6060    const double s = (sld-solvent_sld) * form_volume(radius, length); 
    6161    return 1.0e-4 * square(s * fq); 
  • sasmodels/models/cylinder.py

    r01eece6 r26141cb  
    119119             ] 
    120120 
    121 source = ["lib/J1c.c", "lib/gauss76.c", "cylinder.c"] 
     121source = ["lib/polevl.c","lib/sas_J1.c", "lib/gauss76.c", "cylinder.c"] 
    122122 
    123123def ER(radius, length): 
  • sasmodels/models/ellipsoid.py

    r0a7eec11 rcedad32  
    132132             ] 
    133133 
    134 source = ["lib/J1.c", "lib/sph_j1c.c", "lib/gauss76.c", "ellipsoid.c"] 
     134source = ["lib/sph_j1c.c", "lib/gauss76.c", "ellipsoid.c"] 
    135135 
    136136def ER(rpolar, requatorial): 
  • sasmodels/models/elliptical_cylinder.c

    ra8b3cdb r43b7eea  
    2222        retval = 1.0; 
    2323    }else{ 
    24         retval = 2.0*NR_BessJ1(arg)/arg; 
     24        //retval = 2.0*NR_BessJ1(arg)/arg; 
     25        retval = sas_J1c(arg); 
    2526    } 
    2627    return retval*retval ; 
     
    155156      Be = 0.5; 
    156157    }else{ 
    157       Be = NR_BessJ1(qr)/qr; 
     158      //Be = NR_BessJ1(qr)/qr; 
     159      Be = 0.5*sas_J1c(qr); 
    158160    } 
    159161 
  • sasmodels/models/elliptical_cylinder.py

    raa2edb2 raa24114  
    1212.. figure:: img/elliptical_cylinder_geometry.png 
    1313 
    14     *a* = *r_minor* and |nu|\ :sub:`n` = $r_ratio$ (i.e., $r_major / r_minor$). 
     14   Elliptical cylinder geometry $a$ = $r_{minor}$ and \nu = $r_{ratio}$ = $r_{major} / r_{minor}$ 
    1515 
    1616The function calculated is 
     
    2626    F(\mathbf{q},\alpha,\psi)=2\frac{J_1(a)\sin(b)}{ab} 
    2727    \\ 
    28     a = \mathbf{q}\sin(\alpha)\left[ r^2_{major}\sin^2(\psi)+r^2_{minor}\cos(\psi) \right]^{1/2} 
     28    where  a = \mathbf{q}\sin(\alpha)\left[ r^2_{major}\sin^2(\psi)+r^2_{minor}\cos(\psi) \right]^{1/2} 
    2929    \\ 
    3030    b=\mathbf{q}\frac{L}{2}\cos(\alpha) 
     
    7474    The intensities averaged from 2D over different numbers of bins and angles. 
    7575 
    76 Reference 
    77 --------- 
     76References 
     77---------- 
    7878 
    7979L A Feigin and D I Svergun, *Structure Analysis by Small-Angle X-Ray and Neutron Scattering*, Plenum, 
     
    9898              ["length",      "Ang",        400.0, [1, inf],    "volume",      "Length of the cylinder"], 
    9999              ["sld",         "1e-6/Ang^2", 4.0,   [-inf, inf], "",            "Cylinder scattering length density"], 
    100               ["solvent_sld", "1e-6/Ang^2", 1.0,   [-inf, inf], "",            "Solvent scattering length density"], 
     100              ["sld_solvent", "1e-6/Ang^2", 1.0,   [-inf, inf], "",            "Solvent scattering length density"], 
    101101              ["theta",       "degrees",    90.0,  [-360, 360], "orientation", "In plane angle"], 
    102102              ["phi",         "degrees",    0,     [-360, 360], "orientation", "Out of plane angle"], 
     
    105105# pylint: enable=bad-whitespace, line-too-long 
    106106 
    107 source = ["lib/nr_bess_j1.c", "lib/gauss76.c", "lib/gauss20.c", "elliptical_cylinder.c"] 
     107source = ["lib/polevl.c","lib/sas_J1.c", "lib/gauss76.c", "lib/gauss20.c", "elliptical_cylinder.c"] 
    108108 
    109109demo = dict(scale=1, background=0, r_minor=100, r_ratio=1.5, length=400.0, 
    110             sld=4.0, solvent_sld=1.0, theta=10.0, phi=20, psi=30, theta_pd=10, phi_pd=2, psi_pd=3) 
     110            sld=4.0, sld_solvent=1.0, theta=10.0, phi=20, psi=30, theta_pd=10, phi_pd=2, psi_pd=3) 
    111111 
    112112oldname = 'EllipticalCylinderModel' 
    113 oldpars = dict(theta='cyl_theta', phi='cyl_phi', psi='cyl_psi', sld='sldCyl', solvent_sld='sldSolv') 
     113oldpars = dict(theta='cyl_theta', phi='cyl_phi', psi='cyl_psi', sld='sldCyl', sld_solvent='sldSolv') 
    114114 
    115115def ER(r_minor, r_ratio, length): 
     
    132132           'sld': 4.0, 
    133133           'length':400.0, 
    134            'solvent_sld':1.0, 
     134           'sld_solvent':1.0, 
    135135           'background':0.0 
    136136          }, 0.001, 675.504402]] 
  • sasmodels/models/fcc.py

    r2f0c07d r43b7eea  
    116116# pylint: enable=bad-whitespace, line-too-long 
    117117 
    118 source = ["lib/sph_j1c.c", "lib/J1.c", "lib/gauss150.c", "lib/sphere_form.c", "fcc.c"] 
     118source = ["lib/sph_j1c.c", "lib/gauss150.c", "lib/sphere_form.c", "fcc.c"] 
    119119 
    120120# parameters for demo 
  • sasmodels/models/flexible_cylinder.c

    re7678b2 r43b7eea  
    2525    const double qr = q*radius; 
    2626    //const double crossSect = (2.0*J1(qr)/qr)*(2.0*J1(qr)/qr); 
    27     const double crossSect = J1c(qr); 
     27    const double crossSect = sas_J1c(qr); 
    2828    double flex = Sk_WR(q,length,kuhn_length); 
    2929    flex *= crossSect*crossSect; 
  • sasmodels/models/flexible_cylinder.py

    raa2edb2 rce8bed9  
    3030The Kuhn length $(b = 2*l_p)$ is also used to describe the stiffness of a chain. 
    3131 
    32 The returned value is in units of $cm^-1$, on absolute scale. 
     32The returned value is in units of $cm^{-1}$, on absolute scale. 
    3333 
    34 In the parameters, the sldCyl and sldSolv represent the SLD of the chain/cylinder 
     34In the parameters, the sld and sld\_solvent represent the SLD of the cylinder 
    3535and solvent respectively. 
    3636 
     
    6565title = "Flexible cylinder where the form factor is normalized by the volume" \ 
    6666        "of the cylinder." 
    67 description = """Note : scale and contrast=sld-solvent_sld are both 
     67description = """Note : scale and contrast = (sld - sld_solvent) are both 
    6868                multiplicative factors in the model and are perfectly 
    6969                correlated. One or both of these parameters must be held fixed 
     
    7272 
    7373category = "shape:cylinder" 
    74 single = False 
     74single = False  # double precision only! 
    7575 
    7676# pylint: disable=bad-whitespace, line-too-long 
     
    8181    ["radius",      "Ang",         20.0, [0, inf],    "volume", "Radius of the flexible cylinder"], 
    8282    ["sld",         "1e-6/Ang^2",   1.0, [-inf, inf], "",       "Cylinder scattering length density"], 
    83     ["solvent_sld", "1e-6/Ang^2",   6.3, [-inf, inf], "",       "Solvent scattering length density"], 
     83    ["sld_solvent", "1e-6/Ang^2",   6.3, [-inf, inf], "",       "Solvent scattering length density"], 
    8484    ] 
    8585# pylint: enable=bad-whitespace, line-too-long 
    86 source = ["lib/J1.c", "lib/J1c.c", "lib/wrc_cyl.c", "flexible_cylinder.c"] 
     86source = ["lib/polevl.c", "lib/sas_J1.c", "lib/wrc_cyl.c", "flexible_cylinder.c"] 
    8787 
    8888demo = dict(scale=1.0, background=0.0001, 
     
    9191            radius=20.0, 
    9292            sld=1.0, 
    93             solvent_sld=6.3) 
     93            sld_solvent=6.3) 
    9494 
    9595oldname = 'FlexibleCylinderModel' 
    96 oldpars = dict(sld='sldCyl', solvent_sld='sldSolv') 
     96oldpars = dict(sld='sldCyl', sld_solvent='sldSolv') 
    9797 
    9898 
     
    104104    #  'radius':       20.0, 
    105105    #  'sld':           1.0, 
    106     #  'solvent_sld':   6.3, 
     106    #  'sld_solvent':   6.3, 
    107107    #  'background':    0.0001, 
    108108    #  }, 0.001, 3509.2187], 
     
    113113      'radius':       20.0, 
    114114      'sld':           1.0, 
    115       'solvent_sld':   6.3, 
     115      'sld_solvent':   6.3, 
    116116      'background':    0.0001, 
    117117     }, 1.0, 0.000595345], 
     
    120120      'radius':        2.0, 
    121121      'sld':           6.0, 
    122       'solvent_sld':  12.3, 
     122      'sld_solvent':  12.3, 
    123123      'background':    0.001, 
    124124     }, 0.1, 1.55228], 
     
    127127      'radius':       50.0, 
    128128      'sld':           0.1, 
    129       'solvent_sld':   5.1, 
     129      'sld_solvent':   5.1, 
    130130      'background':    0.0, 
    131131     }, 1.0, 0.000938456] 
  • sasmodels/models/flexible_cylinder_ex.c

    re7678b2 r43b7eea  
    2424        SINCOS(zi, sn, cn); 
    2525        double arg = q*sqrt(a*a*sn*sn+b*b*cn*cn); 
    26         double yyy = pow((double)J1c(arg),2); 
     26        double yyy = pow((double)sas_J1c(arg),2); 
    2727        yyy *= Gauss76Wt[i]; 
    2828        summ += yyy; 
  • sasmodels/models/flexible_cylinder_ex.py

    raa2edb2 rce8bed9  
    2424----------- 
    2525 
    26 The function calculated is from the reference given below. From that paper, 
    27 "Method 3 With Excluded Volume" is used. 
     26The function calculated in a similar way to that for the flexible_cylinder model 
     27from the reference given below using the author's "Method 3 With Excluded Volume". 
    2828The model is a parameterization of simulations of a discrete representation of 
    2929the worm-like chain model of Kratky and Porod applied in the pseudo-continuous 
     
    6262maintain this inequality. 
    6363 
    64 The returned value is in units of $cm^-1$, on absolute scale. 
     64The returned value is in units of $cm^{-1}$, on absolute scale. 
    6565 
    66 In the parameters, the $sldCyl$ and $sldSolv$ represent the SLD of the 
     66In the parameters, the $sld$ and $sld\_solvent$ represent the SLD of the 
    6767chain/cylinder and solvent respectively. The *scale*, and the contrast are both 
    6868multiplicative factors in the model and are perfectly correlated. One or both of 
     
    103103    ["kuhn_length", "Ang",        100.0, [0, inf],    "volume", "Kuhn length of the flexible cylinder"], 
    104104    ["radius",      "Ang",         20.0, [0, inf],    "volume", "Radius of the flexible cylinder"], 
    105     ["axis_ratio",  "",             1.5, [0, inf],    "",       "Axis_ratio (major_radius/radius"], 
     105    ["axis_ratio",  "",             1.5, [0, inf],    "",       "Axis_ratio (major_radius/minor_radius"], 
    106106    ["sld",         "1e-6/Ang^2",   1.0, [-inf, inf], "",       "Cylinder scattering length density"], 
    107     ["solvent_sld", "1e-6/Ang^2",   6.3, [-inf, inf], "",       "Solvent scattering length density"], 
     107    ["sld_solvent", "1e-6/Ang^2",   6.3, [-inf, inf], "",       "Solvent scattering length density"], 
    108108    ] 
    109109# pylint: enable=bad-whitespace, line-too-long 
    110110 
    111 source = ["lib/J1.c", "lib/J1c.c", "lib/gauss76.c", "lib/wrc_cyl.c", "flexible_cylinder_ex.c"] 
     111source = ["lib/polevl.c","lib/sas_J1.c", "lib/gauss76.c", "lib/wrc_cyl.c", "flexible_cylinder_ex.c"] 
    112112 
    113113demo = dict(scale=1.0, background=0.0001, 
     
    117117            axis_ratio=1.5, 
    118118            sld=1.0, 
    119             solvent_sld=6.3) 
     119            sld_solvent=6.3) 
    120120 
    121121oldname = 'FlexCylEllipXModel' 
    122 oldpars = dict(sld='sldCyl', solvent_sld='sldSolv') 
     122oldpars = dict(sld='sldCyl', sld_solvent='sldSolv') 
    123123 
    124124 
     
    131131    #  'axis_ratio':    1.5, 
    132132    #  'sld':           1.0, 
    133     #  'solvent_sld':   6.3, 
     133    #  'sld_solvent':   6.3, 
    134134    #  'background':    0.0001, 
    135135    # }, 0.001, 3509.2187], 
     
    141141      'axis_ratio':    1.5, 
    142142      'sld':           1.0, 
    143       'solvent_sld':   6.3, 
     143      'sld_solvent':   6.3, 
    144144      'background':    0.0001, 
    145145     }, 1.0, 0.00223819], 
     
    149149      'axis_ratio':    0.5, 
    150150      'sld':           6.0, 
    151       'solvent_sld':  12.3, 
     151      'sld_solvent':  12.3, 
    152152      'background':    0.001, 
    153153     }, 0.1, 0.390281], 
     
    157157      'axis_ratio':    4.5, 
    158158      'sld':           0.1, 
    159       'solvent_sld':   5.1, 
     159      'sld_solvent':   5.1, 
    160160      'background':    0.0, 
    161161     }, 1.0, 0.0016338264790] 
  • sasmodels/models/hollow_cylinder.c

    r0420af7 r43b7eea  
    2424        lam1 = 1.0; 
    2525    }else{ 
    26         lam1 = 2.0*J1(arg1)/arg1; 
     26        lam1 = sas_J1c(arg1); 
    2727    } 
    2828    if (arg2 == 0.0){ 
    2929        lam2 = 1.0; 
    3030    }else{ 
    31         lam2 = 2.0*J1(arg2)/arg2; 
     31        lam2 = sas_J1c(arg2); 
    3232    } 
    3333    //Todo: Need to check psi behavior as gamma goes to 1. 
  • sasmodels/models/hollow_cylinder.py

    r01eece6 r43b7eea  
    7979# pylint: enable=bad-whitespace, line-too-long 
    8080 
    81 source = ["lib/J1.c", "lib/gauss76.c", "hollow_cylinder.c"] 
     81source = ["lib/polevl.c","lib/sas_J1.c", "lib/gauss76.c", "hollow_cylinder.c"] 
    8282 
    8383# pylint: disable=W0613 
  • sasmodels/models/hollow_rectangular_prism.py

    raa2edb2 r43b7eea  
    115115             ] 
    116116 
    117 source = ["lib/J1.c", "lib/gauss76.c", "hollow_rectangular_prism.c"] 
     117source = [ "lib/gauss76.c", "hollow_rectangular_prism.c"] 
    118118 
    119119def ER(a_side, b2a_ratio, c2a_ratio, thickness): 
  • sasmodels/models/hollow_rectangular_prism_infinitely_thin_walls.py

    raa2edb2 r43b7eea  
    9999             ] 
    100100 
    101 source = ["lib/J1.c", "lib/gauss76.c", "hollow_rectangular_prism_infinitely_thin_walls.c"] 
     101source = ["lib/gauss76.c", "hollow_rectangular_prism_infinitely_thin_walls.c"] 
    102102 
    103103def ER(a_side, b2a_ratio, c2a_ratio): 
  • sasmodels/models/parallelepiped.py

    raa2edb2 r43b7eea  
    193193             ] 
    194194 
    195 source = ["lib/J1.c", "lib/gauss76.c", "parallelepiped.c"] 
     195source = ["lib/gauss76.c", "parallelepiped.c"] 
    196196 
    197197def ER(a_side, b_side, c_side): 
  • sasmodels/models/rectangular_prism.py

    raa2edb2 r43b7eea  
    107107             ] 
    108108 
    109 source = ["lib/J1.c", "lib/gauss76.c", "rectangular_prism.c"] 
     109source = ["lib/gauss76.c", "rectangular_prism.c"] 
    110110 
    111111def ER(a_side, b2a_ratio, c2a_ratio): 
  • sasmodels/models/stacked_disks.c

    rd507c3a r43b7eea  
    5252        const double sinarg2 = qq*(halfheight+layer_thick)*cos(zi); 
    5353 
    54     const double be1 = J1(besarg1)/besarg1; 
    55         const double be2 = J1(besarg2)/besarg2; 
     54    const double be1 = sas_J1c(besarg1); 
     55        const double be2 = sas_J1c(besarg2); 
    5656        const double si1 = sin(sinarg1)/sinarg1; 
    5757        const double si2 = sin(sinarg2)/sinarg2; 
     
    6262        const double totald=2.0*(layer_thick+halfheight); 
    6363 
    64         const double t1 = 2.0*area*(2.0*halfheight)*dr1*(si1)*(be1); 
    65         const double t2 = 2.0*area*dr2*(totald*si2-2.0*halfheight*si1)*(be2); 
     64        const double t1 = area*(2.0*halfheight)*dr1*(si1)*(be1); 
     65        const double t2 = area*dr2*(totald*si2-2.0*halfheight*si1)*(be2); 
    6666 
    6767 
  • sasmodels/models/stacked_disks.py

    r5111921 r43b7eea  
    133133# pylint: enable=bad-whitespace, line-too-long 
    134134 
    135 source = ["lib/gauss76.c", "lib/J1.c", "stacked_disks.c"] 
     135source = ["lib/polevl.c", "lib/sas_J1.c", "lib/gauss76.c", "stacked_disks.c"] 
    136136 
    137137demo = dict(background=0.001, 
  • sasmodels/models/triaxial_ellipsoid.py

    raa2edb2 r43b7eea  
    104104             ] 
    105105 
    106 source = ["lib/J1.c", "lib/sph_j1c.c", "lib/gauss76.c", "triaxial_ellipsoid.c"] 
     106source = ["lib/sph_j1c.c", "lib/gauss76.c", "triaxial_ellipsoid.c"] 
    107107 
    108108def ER(req_minor, req_major, rpolar): 
Note: See TracChangeset for help on using the changeset viewer.