QtiPlot  0.9.8.2
Public Types | Public Member Functions | Protected Member Functions | Protected Attributes | Private Member Functions | List of all members
Fit Class Reference

Fit base class. More...

#include <Fit.h>

Inheritance diagram for Fit:
Filter ExponentialFit GaussAmpFit LinearFit LinearSlopeFit LogisticFit MultiPeakFit NonLinearFit PluginFit PolynomialFit SigmoidalFit ThreeExpFit TwoExpFit

Public Types

enum  Algorithm { ScaledLevenbergMarquardt, UnscaledLevenbergMarquardt, NelderMeadSimplex }
 
typedef int(* fit_function) (const gsl_vector *, void *, gsl_vector *)
 
typedef int(* fit_function_df) (const gsl_vector *, void *, gsl_matrix *)
 
typedef int(* fit_function_fdf) (const gsl_vector *, void *, gsl_vector *, gsl_matrix *)
 
typedef double(* fit_function_simplex) (const gsl_vector *, void *)
 
enum  FitType { BuiltIn = 0, Plugin = 1, User = 2 }
 
enum  WeightingMethod {
  NoWeighting, Instrumental, Statistical, Dataset,
  Direct
}
 

Public Member Functions

double adjustedRSquare ()
 Returns adjusted R^2. More...
 
double chiSquare ()
 Returns the sum of squares of the residuals from the best-fit line. More...
 
MatrixcovarianceMatrix (const QString &matrixName)
 
double * errors ()
 Returns a vector with the standard deviations of the results. More...
 
virtual double eval (double *, double)
 Calculates the data for the output fit curve. More...
 
QString fileName ()
 
 Fit (ApplicationWindow *parent, QwtPlotCurve *c)
 
 Fit (ApplicationWindow *parent, Graph *g=0, const QString &name=QString())
 
 Fit (ApplicationWindow *parent, Table *t, const QString &name=QString())
 
virtual void fit ()
 Actually does the fit. Should be reimplemented in derived classes. More...
 
QString formula ()
 
void generateFunction (bool yes, int points=100)
 Specifies weather the result of the fit is a function curve. More...
 
virtual void guessInitialValues ()
 
double initialGuess (int parIndex)
 
double lcl (int parIndex, double confidenceLevel)
 Lower Confidence Limit. More...
 
virtual QString legendInfo ()
 Output string added to the plot as a new legend. More...
 
bool load (const QString &fileName)
 
int numParameters ()
 
QStringList parameterNames ()
 
TableparametersTable (const QString &tableName)
 
double * residuals ()
 Returns a vector with the fit residuals. More...
 
QString resultFormula ()
 
double * results ()
 Returns a vector with the fit results. More...
 
double rmse ()
 Returns the Root Mean Squared Error. More...
 
double rSquare ()
 Returns R^2. More...
 
double rss ()
 Returns the Residual Sum of Squares. More...
 
virtual bool run ()
 Actually does the job. Should be reimplemented in derived classes. More...
 
bool save (const QString &fileName)
 
void scaleErrors (bool yes=true)
 Specifies wheather the errors must be scaled with sqrt(chi_2/dof) More...
 
void setAlgorithm (Algorithm s)
 
void setDataCurve (QwtPlotCurve *curve, double start, double end)
 
bool setDataFromTable (Table *t, const QString &xColName, const QString &yColName, int from=1, int to=-1, bool sort=false)
 
void setFileName (const QString &fn)
 
virtual bool setFormula (const QString &, bool=true)
 
void setInitialGuess (int parIndex, double val)
 
void setInitialGuesses (double *x_init)
 
void setParameterExplanations (const QStringList &lst)
 
void setParameterRange (int parIndex, double left, double right)
 
virtual bool setParametersList (const QStringList &)
 
void setType (FitType t)
 
bool setWeightingData (WeightingMethod w, const QString &colName=QString::null)
 Sets the data set to be used for weighting. More...
 
void showConfidenceLimits (double confidenceLevel)
 
void showPredictionLimits (double confidenceLevel)
 
QwtPlotCurve * showResiduals ()
 Plot residuals and display data values in a column. More...
 
FitType type ()
 
double ucl (int parIndex, double confidenceLevel)
 Upper Confidence Limit. More...
 
void writeParametersToTable (Table *t, bool append=false)
 
 ~Fit ()
 
- Public Member Functions inherited from Filter
int dataSize ()
 Returns the size of the input data set. More...
 
virtual void enableGraphicsDisplay (bool on=true, Graph *g=0)
 
bool error ()
 
 Filter (ApplicationWindow *parent, Table *t=0, const QString &name=QString())
 
 Filter (ApplicationWindow *parent, Graph *g=0, const QString &name=QString())
 
 Filter (ApplicationWindow *parent, Matrix *m, const QString &name=QString())
 
 Filter (ApplicationWindow *parent, QwtPlotCurve *c)
 
GraphoutputGraph ()
 Returns a pointer to the graph where the result curve should be displayed. More...
 
QwtPlotCurve * resultCurve ()
 Returns a pointer to the plot curve created to display the results. More...
 
TableresultTable ()
 Returns a pointer to the table created to display the results. More...
 
void setColor (int colorId)
 Obsolete: sets the color of the output fit curve. More...
 
void setColor (const QColor &color)
 Sets the color of the output fit curve. More...
 
void setColor (const QString &colorName)
 Sets the color of the output fit curve. Provided for convenience. To be used in scripts only! More...
 
bool setDataFromCurve (QwtPlotCurve *c)
 
bool setDataFromCurve (QwtPlotCurve *c, double from, double to)
 
bool setDataFromCurve (const QString &curveTitle, Graph *g=0)
 
bool setDataFromCurve (const QString &curveTitle, double from, double to, Graph *g=0)
 
void setError (bool on=true)
 
void setInterval (double from, double to)
 Changes the data range if the source curve was already assigned. Provided for convenience. More...
 
void setMaximumIterations (int iter)
 Sets the maximum number of iterations to be performed during an iterative session. More...
 
void setOutputPoints (int points)
 Sets the number of points in the output curve. More...
 
void setOutputPrecision (int digits)
 Sets the precision used for the output. More...
 
void setSortData (bool on=true)
 
void setTolerance (double eps)
 Sets the tolerance used by the GSL routines. More...
 
void setUpdateOutputGraph (bool update=true)
 
virtual void showLegend ()
 Adds a new legend to the plot. Calls virtual legendInfo() More...
 
double * x ()
 Returns the x values of the input data set. More...
 
double * y ()
 Returns the y values of the input data set. More...
 
 ~Filter ()
 

Protected Member Functions

virtual void calculateFitCurveData (double *X, double *Y)
 Calculates the data for the output fit curve and store itin the X an Y vectors. More...
 
virtual void freeMemory ()
 Frees all the arrays with size d_n. Used when changing the source data sets. More...
 
void freeWorkspace ()
 Frees the memory allocated for the fit workspace. More...
 
virtual void generateFitCurve ()
 Adds the result curve to the plot. More...
 
void initWorkspace (int par)
 Allocates the memory for the fit workspace. More...
 
virtual FunctionCurveinsertFitFunctionCurve (const QString &name, int penWidth=1, bool updateData=true)
 Adds the result curve as a FunctionCurve to the plot, if d_gen_function = true. More...
 
virtual QString logFitInfo (int iterations, int status)
 Output string added to the result log. More...
 
- Protected Member Functions inherited from Filter
QwtPlotCurve * addResultCurve (double *x, double *y)
 Adds the result curve to the target output plot window. Creates a hidden table and frees the input data from memory. More...
 
virtual void calculateOutputData (double *X, double *Y)
 Calculates the data for the output curve and store it in the X an Y vectors. More...
 
MultiLayercreateOutputGraph ()
 
virtual int curveData (QwtPlotCurve *c, double start, double end, double **x, double **y)
 
int curveIndex (const QString &curveTitle, Graph *g)
 Performs checks and returns the index of the source data curve if OK, -1 otherwise. More...
 
int curveRange (QwtPlotCurve *c, double start, double end, int *iStart, int *iEnd)
 
void init ()
 
virtual QString logInfo ()
 Output string added to the log pannel of the application. More...
 
void memoryErrorMessage ()
 
virtual void output ()
 Performs the data analysis and takes care of the output. More...
 
virtual int sortedCurveData (QwtPlotCurve *c, double start, double end, double **x, double **y)
 Same as curveData, but sorts the points by their x value. More...
 

Protected Attributes

double chi_2
 The sum of squares of the residuals from the best-fit line. More...
 
gsl_matrix * covar
 Covariance matrix. More...
 
double d_adjusted_r_square
 Adjusted R^2. More...
 
Matrixd_cov_matrix
 Matrix window used for the output of covariance matrix. More...
 
fit_function_df d_df
 
double * d_errors
 Stores standard deviations of the result parameters. More...
 
fit_function d_f
 
fit_function_fdf d_fdf
 
QString d_file_name
 Path of the XML file where the user stores the fit model. More...
 
FitType d_fit_type
 
QString d_formula
 The fit formula given on input. More...
 
fit_function_simplex d_fsimplex
 
bool d_gen_function
 Specifies weather the result curve is a FunctionCurve or a normal curve with the same x values as the fit data. More...
 
int d_p
 Number of fit parameters. More...
 
QStringList d_param_explain
 Stores a list of short explanations for the significance of the fit parameters. More...
 
gsl_vector * d_param_init
 Initial guesses for the fit parameters. More...
 
QStringList d_param_names
 Names of the fit parameters. More...
 
double * d_param_range_left
 Stores the left limits of the research interval for the result parameters. More...
 
double * d_param_range_right
 Stores the right limits of the research interval for the result parameters. More...
 
QPointer< Tabled_param_table
 Table window used for the output of fit parameters. More...
 
double * d_residuals
 Stores fit residuals. More...
 
QString d_result_formula
 The result fit formula, where the fit parameters are replaced with the calculated values. More...
 
double * d_results
 Stores the result parameters. More...
 
double d_rss
 Residual sum of squares. More...
 
bool d_scale_errors
 Specifies wheather the errors must be scaled with sqrt(chi_2/dof) More...
 
Algorithm d_solver
 Algorithm type. More...
 
double * d_w
 weighting data set used for the fit More...
 
WeightingMethod d_weighting
 The kind of weighting to be performed on the data. More...
 
bool is_non_linear
 Tells whether the fitter uses non-linear/simplex fitting with an initial parameters set, that must be freed in the destructor. More...
 
QString weighting_dataset
 The name of the weighting dataset. More...
 
- Protected Attributes inherited from Filter
QwtPlotCurve * d_curve
 The curve to be analysed. More...
 
QColor d_curveColor
 Color index of the result curve. More...
 
QString d_explanation
 String explaining the operation in the comment of the result table and in the project explorer. More...
 
double d_from
 Data interval. More...
 
Graphd_graph
 The source graph with the curve to be analyzed. More...
 
bool d_graphics_display
 Specifies if the filter should display a result curve. More...
 
bool d_init_err
 Error flag telling if something went wrong during the initialization phase. More...
 
Matrixd_matrix
 
int d_max_iterations
 Maximum number of iterations per fit. More...
 
int d_min_points
 Minimum number of data points necessary to perform the operation. More...
 
int d_n
 Size of the data arrays. More...
 
Graphd_output_graph
 The graph where the result curve should be displayed. More...
 
int d_points
 Number of result points to de calculated and displayed in the output curve. More...
 
int d_prec
 Precision (number of significant digits) used for the results output. More...
 
QwtPlotCurve * d_result_curve
 The resulting curve. More...
 
Tabled_result_table
 The table displaying the results of the filtering operation (not alvays valid!) More...
 
bool d_sort_data
 Specifies if the filter needs sorted data as input. More...
 
Tabled_table
 A table source of data. More...
 
double d_to
 
double d_tolerance
 GSL Tolerance, if ever needed... More...
 
bool d_update_output_graph
 Specifies if the filter should update the output graph. More...
 
double * d_x
 x data set to be analysed More...
 
double * d_y
 y data set to be analysed More...
 
QString d_y_col_name
 

Private Member Functions

virtual void customizeFitResults ()
 Customs and stores the fit results according to the derived class specifications. Used by exponential fits. More...
 
gsl_multifit_fdfsolver * fitGSL (gsl_multifit_function_fdf f, int &iterations, int &status)
 Pointer to the GSL multifit solver. More...
 
gsl_multimin_fminimizer * fitSimplex (gsl_multimin_function f, int &iterations, int &status)
 Pointer to the GSL multifit minimizer (for simplex algorithm) More...
 
void init ()
 
virtual bool removeDataSingularities ()
 Removes any data singularities before fitting. More...
 

Detailed Description

Fit base class.

Member Typedef Documentation

◆ fit_function

typedef int(* Fit::fit_function) (const gsl_vector *, void *, gsl_vector *)

◆ fit_function_df

typedef int(* Fit::fit_function_df) (const gsl_vector *, void *, gsl_matrix *)

◆ fit_function_fdf

typedef int(* Fit::fit_function_fdf) (const gsl_vector *, void *, gsl_vector *, gsl_matrix *)

◆ fit_function_simplex

typedef double(* Fit::fit_function_simplex) (const gsl_vector *, void *)

Member Enumeration Documentation

◆ Algorithm

Enumerator
ScaledLevenbergMarquardt 
UnscaledLevenbergMarquardt 
NelderMeadSimplex 

◆ FitType

Enumerator
BuiltIn 
Plugin 
User 

◆ WeightingMethod

Enumerator
NoWeighting 
Instrumental 
Statistical 
Dataset 
Direct 

Constructor & Destructor Documentation

◆ Fit() [1/3]

Fit::Fit ( ApplicationWindow parent,
QwtPlotCurve *  c 
)

References init().

◆ Fit() [2/3]

Fit::Fit ( ApplicationWindow parent,
Graph g = 0,
const QString &  name = QString() 
)

References init().

◆ Fit() [3/3]

Fit::Fit ( ApplicationWindow parent,
Table t,
const QString &  name = QString() 
)

References init().

◆ ~Fit()

Fit::~Fit ( )

References d_p, freeMemory(), and freeWorkspace().

Member Function Documentation

◆ adjustedRSquare()

double Fit::adjustedRSquare ( )
inline

Returns adjusted R^2.

References d_adjusted_r_square.

◆ calculateFitCurveData()

virtual void Fit::calculateFitCurveData ( double *  X,
double *  Y 
)
inlineprotectedvirtual

Calculates the data for the output fit curve and store itin the X an Y vectors.

Reimplemented in GaussAmpFit, LinearSlopeFit, ThreeExpFit, LinearFit, TwoExpFit, NonLinearFit, PolynomialFit, ExponentialFit, SigmoidalFit, PluginFit, and LogisticFit.

References logFitInfo().

Referenced by generateFitCurve().

◆ chiSquare()

double Fit::chiSquare ( )
inline

Returns the sum of squares of the residuals from the best-fit line.

References chi_2, and rSquare().

Referenced by ApplicationWindow::fitLinear(), and ApplicationWindow::fitSlope().

◆ covarianceMatrix()

Matrix * Fit::covarianceMatrix ( const QString &  matrixName)

◆ customizeFitResults()

virtual void Fit::customizeFitResults ( )
inlineprivatevirtual

Customs and stores the fit results according to the derived class specifications. Used by exponential fits.

Reimplemented in MultiPeakFit, and ExponentialFit.

Referenced by generateFitCurve().

◆ errors()

double * Fit::errors ( )

Returns a vector with the standard deviations of the results.

References chi_2, covar, d_errors, Filter::d_n, d_p, and d_scale_errors.

Referenced by FitDialog::accept(), and results().

◆ eval()

virtual double Fit::eval ( double *  ,
double   
)
inlinevirtual

◆ fileName()

QString Fit::fileName ( )
inline

◆ fit()

void Fit::fit ( )
virtual

◆ fitGSL()

gsl_multifit_fdfsolver * Fit::fitGSL ( gsl_multifit_function_fdf  f,
int &  iterations,
int &  status 
)
private

Pointer to the GSL multifit solver.

References covar, Filter::d_max_iterations, Filter::d_n, d_p, d_param_init, d_param_range_left, d_param_range_right, d_results, d_solver, and Filter::d_tolerance.

Referenced by eval(), and fit().

◆ fitSimplex()

gsl_multimin_fminimizer * Fit::fitSimplex ( gsl_multimin_function  f,
int &  iterations,
int &  status 
)
private

Pointer to the GSL multifit minimizer (for simplex algorithm)

References Filter::d_max_iterations, d_p, d_param_init, d_param_range_left, d_param_range_right, d_results, and Filter::d_tolerance.

Referenced by eval(), and fit().

◆ formula()

QString Fit::formula ( )
inline

◆ freeMemory()

void Fit::freeMemory ( )
protectedvirtual

Frees all the arrays with size d_n. Used when changing the source data sets.

Reimplemented from Filter.

References d_residuals, d_w, and Filter::freeMemory().

Referenced by removeDataSingularities(), and ~Fit().

◆ freeWorkspace()

void Fit::freeWorkspace ( )
protected

◆ generateFitCurve()

void Fit::generateFitCurve ( )
protectedvirtual

◆ generateFunction()

void Fit::generateFunction ( bool  yes,
int  points = 100 
)

◆ guessInitialValues()

virtual void Fit::guessInitialValues ( )
inlinevirtual

◆ init()

void Fit::init ( )
private

◆ initialGuess()

double Fit::initialGuess ( int  parIndex)
inline

◆ initWorkspace()

void Fit::initWorkspace ( int  par)
protected

◆ insertFitFunctionCurve()

FunctionCurve * Fit::insertFitFunctionCurve ( const QString &  name,
int  penWidth = 1,
bool  updateData = true 
)
protectedvirtual

◆ lcl()

double Fit::lcl ( int  parIndex,
double  confidenceLevel 
)

Lower Confidence Limit.

References covar, Filter::d_n, d_p, and d_results.

Referenced by results(), showConfidenceLimits(), and showPredictionLimits().

◆ legendInfo()

QString Fit::legendInfo ( )
virtual

Output string added to the plot as a new legend.

Reimplemented from Filter.

Reimplemented in NonLinearFit, and PolynomialFit.

References chi_2, covar, Filter::d_curve, d_formula, Filter::d_n, d_p, d_param_names, Filter::d_prec, d_results, d_scale_errors, Filter::d_y_col_name, and rSquare().

Referenced by NonLinearFit::legendInfo(), and setAlgorithm().

◆ load()

bool Fit::load ( const QString &  fileName)

◆ logFitInfo()

QString Fit::logFitInfo ( int  iterations,
int  status 
)
protectedvirtual

◆ numParameters()

int Fit::numParameters ( )
inline

◆ parameterNames()

QStringList Fit::parameterNames ( )
inline

◆ parametersTable()

Table * Fit::parametersTable ( const QString &  tableName)

◆ removeDataSingularities()

virtual bool Fit::removeDataSingularities ( )
inlineprivatevirtual

Removes any data singularities before fitting.

Reimplemented in NonLinearFit.

References freeMemory(), freeWorkspace(), generateFitCurve(), initWorkspace(), and insertFitFunctionCurve().

Referenced by fit().

◆ residuals()

double * Fit::residuals ( )

Returns a vector with the fit residuals.

References Filter::d_n, d_residuals, d_results, Filter::d_x, Filter::d_y, Filter::error(), and eval().

Referenced by results().

◆ resultFormula()

QString Fit::resultFormula ( )
inline

References d_result_formula.

◆ results()

double* Fit::results ( )
inline

◆ rmse()

double Fit::rmse ( )
inline

Returns the Root Mean Squared Error.

References Filter::d_n, d_p, and d_rss.

◆ rSquare()

double Fit::rSquare ( )

◆ rss()

double Fit::rss ( )
inline

Returns the Residual Sum of Squares.

References d_rss.

◆ run()

virtual bool Fit::run ( )
inlinevirtual

Actually does the job. Should be reimplemented in derived classes.

Reimplemented from Filter.

References fit(), setDataCurve(), setDataFromTable(), and setWeightingData().

◆ save()

bool Fit::save ( const QString &  fileName)

◆ scaleErrors()

void Fit::scaleErrors ( bool  yes = true)
inline

Specifies wheather the errors must be scaled with sqrt(chi_2/dof)

References covarianceMatrix(), d_scale_errors, fileName(), load(), parametersTable(), save(), and writeParametersToTable().

Referenced by FitDialog::accept(), ApplicationWindow::analyzeCurve(), and ExpDecayDialog::fit().

◆ setAlgorithm()

void Fit::setAlgorithm ( Algorithm  s)
inline

References d_solver, generateFunction(), and legendInfo().

Referenced by FitDialog::accept().

◆ setDataCurve()

void Fit::setDataCurve ( QwtPlotCurve *  curve,
double  start,
double  end 
)
virtual

◆ setDataFromTable()

bool Fit::setDataFromTable ( Table t,
const QString &  xColName,
const QString &  yColName,
int  from = 1,
int  to = -1,
bool  sort = false 
)
virtual

◆ setFileName()

void Fit::setFileName ( const QString &  fn)
inline

◆ setFormula()

virtual bool Fit::setFormula ( const QString &  ,
bool  = true 
)
inlinevirtual

◆ setInitialGuess()

void Fit::setInitialGuess ( int  parIndex,
double  val 
)
inline

◆ setInitialGuesses()

void Fit::setInitialGuesses ( double *  x_init)

◆ setParameterExplanations()

void Fit::setParameterExplanations ( const QStringList &  lst)
inline

References d_param_explain.

Referenced by FitModelHandler::endElement().

◆ setParameterRange()

void Fit::setParameterRange ( int  parIndex,
double  left,
double  right 
)

◆ setParametersList()

virtual bool Fit::setParametersList ( const QStringList &  )
inlinevirtual

Reimplemented in NonLinearFit.

Referenced by FitModelHandler::endElement().

◆ setType()

void Fit::setType ( FitType  t)
inline

References d_fit_type.

Referenced by FitModelHandler::endElement().

◆ setWeightingData()

bool Fit::setWeightingData ( WeightingMethod  w,
const QString &  colName = QString::null 
)

◆ showConfidenceLimits()

void Fit::showConfidenceLimits ( double  confidenceLevel)

◆ showPredictionLimits()

void Fit::showPredictionLimits ( double  confidenceLevel)

◆ showResiduals()

QwtPlotCurve * Fit::showResiduals ( )

◆ type()

FitType Fit::type ( )
inline

◆ ucl()

double Fit::ucl ( int  parIndex,
double  confidenceLevel 
)

Upper Confidence Limit.

References covar, Filter::d_n, d_p, and d_results.

Referenced by results(), showConfidenceLimits(), and showPredictionLimits().

◆ writeParametersToTable()

void Fit::writeParametersToTable ( Table t,
bool  append = false 
)

Member Data Documentation

◆ chi_2

double Fit::chi_2
protected

The sum of squares of the residuals from the best-fit line.

Referenced by chiSquare(), errors(), PolynomialFit::fit(), fit(), LinearFit::fit(), LinearSlopeFit::fit(), init(), legendInfo(), logFitInfo(), and writeParametersToTable().

◆ covar

gsl_matrix* Fit::covar
protected

◆ d_adjusted_r_square

double Fit::d_adjusted_r_square
protected

Adjusted R^2.

Referenced by adjustedRSquare(), init(), logFitInfo(), and rSquare().

◆ d_cov_matrix

Matrix* Fit::d_cov_matrix
protected

Matrix window used for the output of covariance matrix.

Referenced by covarianceMatrix(), and init().

◆ d_df

fit_function_df Fit::d_df
protected

◆ d_errors

double* Fit::d_errors
protected

Stores standard deviations of the result parameters.

Referenced by errors(), freeWorkspace(), and init().

◆ d_f

fit_function Fit::d_f
protected

◆ d_fdf

fit_function_fdf Fit::d_fdf
protected

◆ d_file_name

QString Fit::d_file_name
protected

Path of the XML file where the user stores the fit model.

Referenced by fileName(), load(), save(), and setFileName().

◆ d_fit_type

FitType Fit::d_fit_type
protected

◆ d_formula

QString Fit::d_formula
protected

◆ d_fsimplex

fit_function_simplex Fit::d_fsimplex
protected

◆ d_gen_function

bool Fit::d_gen_function
protected

◆ d_p

int Fit::d_p
protected

◆ d_param_explain

QStringList Fit::d_param_explain
protected

◆ d_param_init

gsl_vector* Fit::d_param_init
protected

◆ d_param_names

QStringList Fit::d_param_names
protected

◆ d_param_range_left

double* Fit::d_param_range_left
protected

Stores the left limits of the research interval for the result parameters.

Referenced by fitGSL(), fitSimplex(), freeWorkspace(), init(), initWorkspace(), and setParameterRange().

◆ d_param_range_right

double* Fit::d_param_range_right
protected

Stores the right limits of the research interval for the result parameters.

Referenced by fitGSL(), fitSimplex(), freeWorkspace(), init(), initWorkspace(), and setParameterRange().

◆ d_param_table

QPointer<Table> Fit::d_param_table
protected

Table window used for the output of fit parameters.

Referenced by init(), and parametersTable().

◆ d_residuals

double* Fit::d_residuals
protected

Stores fit residuals.

Referenced by freeMemory(), init(), residuals(), rSquare(), and showResiduals().

◆ d_result_formula

QString Fit::d_result_formula
protected

The result fit formula, where the fit parameters are replaced with the calculated values.

Referenced by init(), and resultFormula().

◆ d_results

double* Fit::d_results
protected

◆ d_rss

double Fit::d_rss
protected

Residual sum of squares.

Referenced by init(), logFitInfo(), rmse(), rSquare(), rss(), showConfidenceLimits(), and showPredictionLimits().

◆ d_scale_errors

bool Fit::d_scale_errors
protected

Specifies wheather the errors must be scaled with sqrt(chi_2/dof)

Referenced by errors(), PolynomialFit::init(), LinearFit::init(), LinearSlopeFit::init(), init(), legendInfo(), logFitInfo(), scaleErrors(), and writeParametersToTable().

◆ d_solver

Algorithm Fit::d_solver
protected

Algorithm type.

Referenced by fit(), fitGSL(), init(), logFitInfo(), and setAlgorithm().

◆ d_w

double* Fit::d_w
protected

◆ d_weighting

WeightingMethod Fit::d_weighting
protected

The kind of weighting to be performed on the data.

Referenced by PolynomialFit::fit(), LinearFit::fit(), LinearSlopeFit::fit(), init(), logFitInfo(), setDataCurve(), and setWeightingData().

◆ is_non_linear

bool Fit::is_non_linear
protected

Tells whether the fitter uses non-linear/simplex fitting with an initial parameters set, that must be freed in the destructor.

Referenced by PolynomialFit::init(), LinearFit::init(), LinearSlopeFit::init(), init(), and logFitInfo().

◆ weighting_dataset

QString Fit::weighting_dataset
protected

The name of the weighting dataset.

Referenced by init(), logFitInfo(), setDataCurve(), and setWeightingData().


The documentation for this class was generated from the following files: