在 scipy.optimize.curve_fit 中使用 absolute_sigma 参数

Using the absolute_sigma parameter in scipy.optimize.curve_fit

为了进行合身,我目前正在使用 scipy.optimize 中的 curve_fit

我已经计算了与每个 ydata 相关的误差,我想将数据中存在的计算 sigma = y_errors 添加到拟合中,

即最小化 sum( ((f(xdata, *popt) - ydata) / sigma)**2 ) 而不仅仅是 sum( (f(xdata, *popt) - ydata))

我在文档中看到可以完成分配参数sigma。我不太清楚的是 absolute_sigma 参数。文档中给出的解释让我很困惑。

我应该设置absolute_sigma= = True吗?或者如果我需要考虑与我的每个 ydata?

关联的 y_errors,它应该设置为 False

如果您的数据具有 绝对 不确定性,即如果您的 y_errors 的单位与 ydata 的单位相同,那么您应该设置 absolute_sigma= = True。然而,通常情况下 y_errors 的单位并不准确,只有相对大小是已知的。后一种情况的示例可能是某些 y 值来自相同 x 值的重复测量。那么将重复的 y 值的权重设置为非重复的 y 值的两倍是有意义的,但是该权重的单位 (2) 与y 的单位是。

下面是一些代码来说明区别:

import numpy as np
from scipy.optimize import curve_fit
from scipy.stats import norm

# defining a model
def model(x, a, b):
    return a * np.exp(-b * x)

# defining the x vector and the real value of some parameters
x_vector = np.arange(100)
a_real, b_real = 1, 0.05

# some toy data with multiplicative uncertainty
y_vector = model(x_vector, a_real, b_real) * (1 + norm.rvs(scale=0.08, size=100))

# fit the parameters, equal weighting on all data points
params, cov = curve_fit(model, x_vector, y_vector )
print params
print cov


# fit the parameters, weighting each data point by its inverse value
params, cov = curve_fit(model, x_vector, y_vector, 
                        sigma=1/y_vector, absolute_sigma=False)
print params
print cov

# with absolute_sigma=False:
## multiplicative transformations of y_data don't matter
params, cov = curve_fit(model, x_vector, y_vector, 
                        sigma=100/y_vector, absolute_sigma=False)
print params
print cov

# but absolute_sigma=True:
## multiplicative transformations of sigma carry through to pcov
params, cov = curve_fit(model, x_vector, y_vector,
                        sigma=100/y_vector, absolute_sigma=True)
print params
print cov

[ 1.03190409  0.05093425]
[[  1.15344847e-03   5.70001955e-05]
 [  5.70001955e-05   5.92595318e-06]]

[ 1.0134898   0.04872328]
[[  1.57940876e-04   1.56490218e-05]
 [  1.56490218e-05   3.56159680e-06]]

[ 1.0134898   0.04872328]
[[  1.57940878e-04   1.56490220e-05]
 [  1.56490220e-05   3.56159682e-06]]

[ 1.0134898   0.04872328]
[[ 2978.10865352   295.07552766]
 [  295.07552766    67.15691613]]