コード例 #1
0
 astmodels.Sine1D(amplitude=10., frequency=0.5, phase=1.),
 astmodels.Cosine1D(amplitude=10., frequency=0.5, phase=1.),
 astmodels.Tangent1D(amplitude=10., frequency=0.5, phase=1.),
 astmodels.ArcSine1D(amplitude=10., frequency=0.5, phase=1.),
 astmodels.ArcCosine1D(amplitude=10., frequency=0.5, phase=1.),
 astmodels.ArcTangent1D(amplitude=10., frequency=0.5, phase=1.),
 astmodels.Trapezoid1D(amplitude=10., x_0=0.5, width=5., slope=1.),
 astmodels.TrapezoidDisk2D(amplitude=10.,
                           x_0=0.5,
                           y_0=1.5,
                           R_0=5.,
                           slope=1.),
 astmodels.Voigt1D(x_0=0.55, amplitude_L=10., fwhm_L=0.5, fwhm_G=0.9),
 astmodels.BlackBody(scale=10.0, temperature=6000. * u.K),
 astmodels.Drude1D(amplitude=10.0, x_0=0.5, fwhm=2.5),
 astmodels.Plummer1D(mass=10.0, r_plum=5.0),
 astmodels.BrokenPowerLaw1D(amplitude=10,
                            x_break=0.5,
                            alpha_1=2.0,
                            alpha_2=3.5),
 astmodels.ExponentialCutoffPowerLaw1D(10, 0.5, 2.0, 7.),
 astmodels.LogParabola1D(
     amplitude=10,
     x_0=0.5,
     alpha=2.,
     beta=3.,
 ),
 astmodels.PowerLaw1D(amplitude=10., x_0=0.5, alpha=2.0),
 astmodels.SmoothlyBrokenPowerLaw1D(amplitude=10.,
                                    x_break=5.0,
                                    alpha_1=2.0,
コード例 #2
0
        lookup_table=np.arange(0, 9).reshape(3, 3),
        bounds_error=False,
        fill_value=None,
        method="nearest",
    ),
    astropy_models.Tabular2D(
        points=([1, 2, 3], [1, 2, 3]) * u.pix,
        lookup_table=np.arange(0, 9).reshape(3, 3) * u.nm,
        bounds_error=False,
        fill_value=None,
        method="nearest",
    ),
]

if astropy.__version__ >= "4.1":
    SINGLE_MODELS.append(astropy_models.Plummer1D(mass=10.0, r_plum=5.0))

UNSUPPORTED_MODELS = [
    # Deprecated models:
    astropy.modeling.functional_models.MexicanHat1D,
    astropy.modeling.functional_models.MexicanHat2D,

    # FITS-specific and deemed unworthy of ASDF serialization:
    astropy.modeling.polynomial.InverseSIP,
    astropy.modeling.polynomial.SIP,

    # Base classes which should not be directly supported:
    astropy.modeling.core.Model,
    astropy.modeling.math_functions._NPUfuncModel,
    astropy.modeling.polynomial.OrthoPolynomialBase,
    astropy.modeling.polynomial.PolynomialModel,