Inheritance diagram for ObjCryst::PowderPattern:
Public Member Functions | |
PowderPattern () | |
PowderPattern (const PowderPattern &) | |
~PowderPattern () | |
virtual const string & | GetClassName () const |
Name for this class ("RefinableObj", "Crystal",...). | |
void | AddPowderPatternComponent (PowderPatternComponent &) |
Add a component (phase, backround) to this pattern. | |
unsigned int | GetNbPowderPatternComponent () const |
Number of components. | |
const PowderPatternComponent & | GetPowderPatternComponent (const string &name) const |
Access to a component of the powder pattern. | |
const PowderPatternComponent & | GetPowderPatternComponent (const int) const |
Access to a component of the powder pattern. | |
PowderPatternComponent & | GetPowderPatternComponent (const string &name) |
Access to a component of the powder pattern. | |
PowderPatternComponent & | GetPowderPatternComponent (const int) |
Access to a component of the powder pattern. | |
void | SetPowderPatternPar (const REAL min, const REAL step, unsigned long nbPoint) |
the powder pattern angular range & resolution parameter. | |
void | SetPowderPatternX (const CrystVector_REAL &x) |
Set the x coordinate of the powder pattern : either the 2theta or time-of-flight values for each recorded point. | |
unsigned long | GetNbPoint () const |
Number of points ? | |
unsigned long | GetNbPointUsed () const |
Number of points actually calculated (below the chosen max(sin(theta)/lambda)) ? | |
void | SetRadiation (const Radiation &radiation) |
Set the radiation. | |
const Radiation & | GetRadiation () const |
Neutron or x-ray experiment ? | |
Radiation & | GetRadiation () |
Neutron or x-ray experiment ? | |
void | SetRadiationType (const RadiationType radiation) |
Set the radiation type. | |
RadiationType | GetRadiationType () const |
Neutron or x-ray experiment ? | |
void | SetWavelength (const REAL lambda) |
Set the wavelength of the experiment (in Angstroems). | |
void | SetWavelength (const string &XRayTubeElementName, const REAL alpha12ratio=0.5) |
Set the wavelength of the experiment to that of an X-Ray tube. | |
void | SetEnergy (const REAL energy) |
Set the energy of the experiment [in keV, lambda(A)=12398/E(keV)]. | |
REAL | GetWavelength () const |
wavelength of the experiment (in Angstroems) | |
const CrystVector_REAL & | GetPowderPatternCalc () const |
Get the calculated powder pattern. | |
const CrystVector_REAL & | GetPowderPatternObs () const |
Get the observed powder pattern. | |
const CrystVector_REAL & | GetPowderPatternObsSigma () const |
Get the sigma for each point of the observed powder pattern. | |
const CrystVector_REAL & | GetPowderPatternVariance () const |
Get the variance (obs+model) for each point of the powder pattern. | |
const CrystVector_REAL & | GetPowderPatternWeight () const |
Get the weight for each point of the powder pattern. | |
REAL | GetPowderPatternXMin () const |
Get the Minimum 2theta. | |
REAL | GetPowderPatternXStep () const |
Get the average step in 2theta. | |
REAL | GetPowderPatternXMax () const |
Get the maximum 2theta. | |
const CrystVector_REAL & | GetPowderPatternX () const |
Get the vector of X (2theta or time-of-flight) coordinates. | |
const CrystVector_REAL & | GetChi2Cumul () const |
Get the powder pattern cumulative Chi^2. | |
const RefinableObjClock & | GetClockPowderPatternCalc () const |
Last time the pattern was calculated. | |
const RefinableObjClock & | GetClockPowderPatternPar () const |
When were the pattern parameters (2theta range, step) changed ? | |
const RefinableObjClock & | GetClockPowderPatternRadiation () const |
When were the radiation parameter (radiation type, wavelength) changed ? | |
const RefinableObjClock & | GetClockPowderPatternXCorr () const |
When were the parameters for 2theta/TOF correction (zero, transparency, displacement) last changed ? | |
void | SetXZero (const REAL newZero) |
Change Zero in x (2theta,tof). | |
void | Set2ThetaDisplacement (const REAL displacement) |
Change displacement correction . | |
void | Set2ThetaTransparency (const REAL transparency) |
Change transparency correction . | |
void | ImportPowderPatternFullprof (const string &fullprofFileName) |
Import fullprof-style diffraction data. | |
void | ImportPowderPatternPSI_DMC (const string &filename) |
Import powder pattern, format DMC from PSI. | |
void | ImportPowderPatternILL_D1A5 (const string &filename) |
Import powder pattern, format from ILL D1A/D2B (format without counter info). | |
void | ImportPowderPatternXdd (const string &fileName) |
Import *.xdd diffraction data (Topas,...). | |
void | ImportPowderPatternSietronicsCPI (const string &fileName) |
Import *.cpi Sietronics diffraction data. | |
void | ImportPowderPattern2ThetaObsSigma (const string &fileName, const int nbSkip=0) |
Import file with 3 columns 2Theta Iobs Sigma. | |
void | ImportPowderPatternFullprof4 (const string &fileName) |
Import diffraction data from a file, with the first line has 2ThetaMin, step, 2thetaMax, and the following lines alternate 10 Iobs and 10 sigma. Ends with null entries (to fill last Iobs line to reach last sigme line). | |
void | ImportPowderPatternMultiDetectorLLBG42 (const string &fileName) |
diffraction data in a multi-detector format (fullprof format #6). | |
void | ImportPowderPattern2ThetaObs (const string &fileName, const int nbSkip=0) |
Import file with 2 columns 2Theta Iobs. | |
void | ImportPowderPatternTOF_ISIS_XYSigma (const string &fileName) |
Import TOF file (ISIS type, 3 columns t, Iobs, sigma(Iobs)). | |
void | ImportPowderPatternGSAS (const string &fileName) |
Import GSAS standard powder pattern data (see GSAS manual). | |
void | ImportPowderPatternCIF (const CIF &cif) |
Import CIF powder pattern data. | |
void | SetPowderPatternObs (const CrystVector_REAL &obs) |
Set observed powder pattern from vector array. | |
void | SavePowderPattern (const string &filename="powderPattern.out") const |
Save powder pattern to one file, text format, 3 columns theta Iobs Icalc. | |
void | PrintObsCalcData (ostream &os=cout) const |
Print to thee screen/console the observed and calculated pattern (long, mostly useful for debugging). | |
REAL | GetR () const |
Unweighted R-factor. | |
REAL | GetIntegratedR () const |
REAL | GetRw () const |
Get the weighted R-factor. | |
REAL | GetIntegratedRw () const |
REAL | GetChi2 () const |
Return conventionnal Chi^2. | |
void | FitScaleFactorForR () const |
Fit the scale(s) factor of each component to minimize R. | |
void | FitScaleFactorForIntegratedR () const |
void | FitScaleFactorForRw () const |
Fit the scale(s) factor of each component to minimize Rw. | |
void | FitScaleFactorForIntegratedRw () const |
void | SetSigmaToSqrtIobs () |
Set sigma=sqrt(Iobs). | |
void | SetWeightToInvSigmaSq (const REAL minRelatSigma=1e-3) |
Set w = 1/sigma^2. | |
void | SetWeightToUnit () |
Set w = 1. | |
void | SetWeightPolynomial (const REAL a, const REAL b, const REAL c, const REAL minRelatIobs=1e-3) |
Set w = 1/(a+ Iobs + b*Iobs^2+c*Iobs^3). | |
void | AddExcludedRegion (const REAL min2Theta, const REAL max2theta) |
Add an Exclusion region, in 2theta, which will be ignored when computing R's XMLInput values must be, as always, in radians. | |
virtual void | BeginOptimization (const bool allowApproximations=false, const bool enableRestraints=false) |
This should be called by any optimization class at the begining of an optimization. | |
virtual void | GlobalOptRandomMove (const REAL mutationAmplitude, const RefParType *type=gpRefParTypeObjCryst) |
Make a random move of the current configuration. | |
virtual REAL | GetLogLikelihood () const |
Get -log(likelihood) of the current configuration for the object. | |
virtual unsigned int | GetNbLSQFunction () const |
Number of LSQ functions. | |
virtual const CrystVector_REAL & | GetLSQCalc (const unsigned int) const |
Get the current calculated value for the LSQ function. | |
virtual const CrystVector_REAL & | GetLSQObs (const unsigned int) const |
Get the observed values for the LSQ function. | |
virtual const CrystVector_REAL & | GetLSQWeight (const unsigned int) const |
Get the weight values for the LSQ function. | |
virtual void | XMLOutput (ostream &os, int indent=0) const |
Output to stream in well-formed XML. | |
virtual void | XMLInput (istream &is, const XMLCrystTag &tag) |
Input From stream. | |
void | Prepare () |
Prepare everything (if necessary) for an optimization/calculation. | |
virtual void | GetGeneGroup (const RefinableObj &obj, CrystVector_uint &groupIndex, unsigned int &firstGroup) const |
Get the gene group assigned to each parameter. | |
virtual void | SetMaxSinThetaOvLambda (const REAL max) |
Set the maximum value for sin(theta)/lambda. | |
REAL | GetMaxSinThetaOvLambda () const |
Get the maximum value for sin(theta)/lambda. | |
const CrystVector_long & | GetIntegratedProfileMin () const |
Get the list of first pixels for the integration intervals. | |
const CrystVector_long & | GetIntegratedProfileMax () const |
Get the list of last pixels for the integration intervals. | |
const RefinableObjClock & | GetIntegratedProfileLimitsClock () const |
When were the integration intervals last changed ? | |
REAL | X2XCorr (const REAL x) const |
Get the experimental x (2theta, tof) from the theoretical value, taking into account all corrections (zero, transparency,..). | |
REAL | X2PixelCorr (const REAL x) const |
Get the pixel number on the experimental pattern, from the theoretical (uncorrected) x coordinate, taking into account all corrections. | |
REAL | X2Pixel (const REAL x) const |
Get the pixel number on the experimental pattern, corresponding to a given (experimental) x coordinate. | |
REAL | STOL2X (const REAL stol) const |
Convert sin(theta)/lambda to X (i.e. | |
REAL | X2STOL (const REAL x) const |
Convert X (either 2theta or TOF) to sin(theta)/lambda, depending on the type of radiation. | |
REAL | STOL2Pixel (const REAL stol) const |
Convert sin(theta)/lambda to pixel, depending on the type of radiation. | |
Protected Member Functions | |
void | CalcPowderPattern () const |
Calc the powder pattern. | |
void | CalcPowderPatternIntegrated () const |
Calc the integrated powder pattern. | |
virtual void | Init () |
Init parameters and options. | |
void | PrepareIntegratedRfactor () const |
Prepare the calculation of the integrated R-factors. | |
void | CalcNbPointUsed () const |
Calculate the number of points of the pattern actually used, from the maximum value of sin(theta)/lambda. | |
virtual void | InitOptions () |
Initialize options. | |
Protected Attributes | |
CrystVector_REAL | mPowderPatternCalc |
The calculated powder pattern. | |
CrystVector_REAL | mPowderPatternIntegratedCalc |
The calculated powder pattern, integrated. | |
CrystVector_REAL | mPowderPatternBackgroundCalc |
The calculated powder pattern part which corresponds to 'background' (eg non-scalable components). | |
CrystVector_REAL | mPowderPatternBackgroundIntegratedCalc |
The calculated powder pattern part which corresponds to 'background' (eg non-scalable components), integrated. | |
CrystVector_REAL | mPowderPatternObs |
The observed powder pattern. | |
CrystVector_REAL | mPowderPatternObsSigma |
The sigma of the observed pattern. | |
CrystVector_REAL | mPowderPatternWeight |
The weight for each point of the pattern. | |
CrystVector_REAL | mPowderPatternVariance |
The complete variance associated to each point of the powder pattern, taking into account observation and model errors. | |
CrystVector_REAL | mPowderPatternVarianceIntegrated |
The complete variance associated to each point of the powder pattern, taking into account observation and model errors. | |
CrystVector_REAL | mChi2Cumul |
The cumulative Chi^2 (integrated or not, depending on the option). | |
CrystVector_REAL | mX |
Vector of x coordinates (either 2theta or time-of-flight) for the pattern. | |
bool | mIsXAscending |
Is the mX vector sorted in ascending order ? (true for 2theta, false for TOF). | |
unsigned long | mNbPoint |
Number of points in the pattern. | |
Radiation | mRadiation |
The Radiation corresponding to this experiment. | |
RefinableObjClock | mClockPowderPatternPar |
When were the pattern parameters (2theta or time-of-flight range) changed ? | |
RefinableObjClock | mClockPowderPatternRadiation |
When were the radiation parameter (radiation type, wavelength) changed ? | |
RefinableObjClock | mClockPowderPatternCalc |
When was the powder pattern last computed ? | |
RefinableObjClock | mClockPowderPatternIntegratedCalc |
When was the powder pattern (integrated) last computed ? | |
RefinableObjClock | mClockPowderPatternXCorr |
Corrections to 2Theta. | |
RefinableObjClock | mClockScaleFactor |
Last modification of the scale factor. | |
CrystVector_REAL | mExcludedRegionMinX |
Min coordinate for for all excluded regions. | |
CrystVector_REAL | mExcludedRegionMaxX |
Max coordinate for 2theta for all excluded regions. | |
REAL | mXZero |
Zero correction : Thus mPowderPattern2ThetaMin=(mPowderPattern2ThetaMin-m2ThetaZero). | |
REAL | m2ThetaDisplacement |
Displacement correction : . | |
REAL | m2ThetaTransparency |
Transparency correction : . | |
REAL | mDIFC |
Time Of Flight (TOF) parameters : . | |
REAL | mDIFA |
Time Of Flight (TOF) parameters : . | |
ObjRegistry< PowderPatternComponent > | mPowderPatternComponentRegistry |
The components (crystalline phases, background,...) of the powder pattern. | |
CrystVector_REAL | mScaleFactor |
The scale factors for each component. | |
bool | mUseFastLessPreciseFunc |
Use faster, less precise functions ? | |
bool | mStatisticsExcludeBackground |
Should Statistics (R, Rw,..) exclude the background ? | |
CrystVector_int | mScalableComponentIndex |
CrystMatrix_REAL | mFitScaleFactorM |
Used to fit the components' scale factors. | |
CrystMatrix_REAL | mFitScaleFactorB |
Used to fit the components' scale factors. | |
CrystMatrix_REAL | mFitScaleFactorX |
Used to fit the components' scale factors. | |
RefObjOpt | mOptProfileIntegration |
Use Integrated profiles for Chi^2, R, Rwp... | |
CrystVector_long | mIntegratedPatternMin |
CrystVector_long | mIntegratedPatternMax |
CrystVector_REAL | mIntegratedObs |
CrystVector_REAL | mIntegratedWeight |
CrystVector_REAL | mIntegratedWeightObs |
CrystVector_REAL | mIntegratedVarianceObs |
RefinableObjClock | mClockIntegratedFactorsPrep |
REAL | mChi2 |
REAL | mChi2LikeNorm |
This is the logarithm of the part of log(Likelihood) which corresponds to the normalization terms of gaussian distribution for each obs/calc point. | |
REAL | mR |
REAL | mRw |
RefinableObjClock | mClockChi2 |
Clock the last time Chi^2 was computed. | |
REAL | mMaxSinThetaOvLambda |
Maximum sin(theta)/lambda for all calculations (10 by default). | |
unsigned long | mNbPointUsed |
Number of points actually used, due to the maximum value of sin(theta)/lambda. | |
unsigned long | mNbIntegrationUsed |
Number of integration intervals actually used, due to the maximum value of sin(theta)/lambda. | |
RefinableObjClock | mClockNbPointUsed |
Clock recording the last time the number of points used (PowderPattern::mNbPointUsed) was changed. |
This can also be used for simulation, using a fake Iobs. Supports multiple phases.
|
|
|
|
|
|
|
Add an Exclusion region, in 2theta, which will be ignored when computing R's XMLInput values must be, as always, in radians. Does not work yet with integrated R factors. Note that the pattern is still computed in these regions. They are only ignored by statistics functions (R, Rws). |
|
Add a component (phase, backround) to this pattern. It must have been allocated in the heap. The pattern parameters (2theta min, step, nbpoints, wavelength, radiation type) of the component are automatically changed to that of the PowderPattern object. |
|
This should be called by any optimization class at the begining of an optimization. This will also check that everything is ready, eg call the RefinableObj::Prepare() function. This also affects all sub-objects.
Reimplemented from ObjCryst::RefinableObj. |
|
Calculate the number of points of the pattern actually used, from the maximum value of sin(theta)/lambda.
|
|
Calc the powder pattern.
|
|
Calc the integrated powder pattern.
|
|
|
|
|
|
Fit the scale(s) factor of each component to minimize R.
|
|
Fit the scale(s) factor of each component to minimize Rw.
|
|
Return conventionnal Chi^2.
|
|
Get the powder pattern cumulative Chi^2. Depending on the chosen option, it will be calculated in an integrated manner or not. The vector is recomputed on every call, so this is slow. |
|
Name for this class ("RefinableObj", "Crystal",...). This is only useful to distinguish different classes when picking up objects from the RefinableObj Global Registry Reimplemented from ObjCryst::RefinableObj. |
|
Last time the pattern was calculated.
|
|
When were the pattern parameters (2theta range, step) changed ?
|
|
When were the radiation parameter (radiation type, wavelength) changed ?
|
|
When were the parameters for 2theta/TOF correction (zero, transparency, displacement) last changed ?
|
|
Get the gene group assigned to each parameter. Each parameter (a gene in terms of genetic algorithms) can be assigned to a gene group. Thus when mating two configurations, genes will be exchanged by groups. By default (in the base RefinabeObj class), each parameter is alone in its group. Derived classes can group genes for a better s** life. The number identifying a gene group only has a meaning in a given object. It can also change on subsequent calls, and thus is not unique.
Reimplemented from ObjCryst::RefinableObj. |
|
When were the integration intervals last changed ?
|
|
Get the list of last pixels for the integration intervals.
|
|
Get the list of first pixels for the integration intervals.
|
|
|
|
|
|
Get -log(likelihood) of the current configuration for the object. By default (no likelihood evaluation available), this is equal to 0. This call should not be recursive, it is the task of the algorithm to get the sum of likelihoods for all objects invlolved.
Reimplemented from ObjCryst::RefinableObj. |
|
Get the current calculated value for the LSQ function.
Reimplemented from ObjCryst::RefinableObj. |
|
Get the observed values for the LSQ function.
Reimplemented from ObjCryst::RefinableObj. |
|
Get the weight values for the LSQ function.
Reimplemented from ObjCryst::RefinableObj. |
|
Get the maximum value for sin(theta)/lambda.
|
|
Number of LSQ functions.
Reimplemented from ObjCryst::RefinableObj. |
|
Number of points ?
|
|
Number of points actually calculated (below the chosen max(sin(theta)/lambda)) ?
|
|
Number of components.
|
|
Get the calculated powder pattern.
|
|
Access to a component of the powder pattern.
|
|
Access to a component of the powder pattern.
|
|
Access to a component of the powder pattern.
|
|
Access to a component of the powder pattern.
|
|
Get the observed powder pattern.
|
|
Get the sigma for each point of the observed powder pattern.
|
|
Get the variance (obs+model) for each point of the powder pattern.
|
|
Get the weight for each point of the powder pattern.
|
|
Get the vector of X (2theta or time-of-flight) coordinates.
|
|
Get the maximum 2theta.
|
|
Get the Minimum 2theta.
|
|
Get the average step in 2theta.
|
|
Unweighted R-factor.
|
|
Neutron or x-ray experiment ?
|
|
Neutron or x-ray experiment ?
|
|
Neutron or x-ray experiment ?
|
|
Get the weighted R-factor.
|
|
wavelength of the experiment (in Angstroems)
|
|
Make a random move of the current configuration. This is for global optimization algorithms. the moves for each parameter are less than their global optimization step, multiplied by the mutation amplitude.
Reimplemented from ObjCryst::RefinableObj. |
|
Import file with 2 columns 2Theta Iobs.
|
|
Import file with 3 columns 2Theta Iobs Sigma.
|
|
Import CIF powder pattern data.
|
|
Import fullprof-style diffraction data.
|
|
Import diffraction data from a file, with the first line has 2ThetaMin, step, 2thetaMax, and the following lines alternate 10 Iobs and 10 sigma. Ends with null entries (to fill last Iobs line to reach last sigme line). That's fullprof format #4.
|
|
Import GSAS standard powder pattern data (see GSAS manual).
|
|
Import powder pattern, format from ILL D1A/D2B (format without counter info).
|
|
diffraction data in a multi-detector format (fullprof format #6). First line is text. Third entry of second line is the 2theta step. Third line has the 2thetamin, fourth line has monitors and temperatures. Then each line has ten pairs (I2,I8)of NbCounters,intensity. Ends with negative entries.
|
|
Import powder pattern, format DMC from PSI.
|
|
Import *.cpi Sietronics diffraction data.
|
|
Import TOF file (ISIS type, 3 columns t, Iobs, sigma(Iobs)).
|
|
Import *.xdd diffraction data (Topas,...).
|
|
Init parameters and options.
|
|
Initialize options.
|
|
Prepare everything (if necessary) for an optimization/calculation.
Reimplemented from ObjCryst::RefinableObj. |
|
Prepare the calculation of the integrated R-factors.
|
|
Print to thee screen/console the observed and calculated pattern (long, mostly useful for debugging).
|
|
Save powder pattern to one file, text format, 3 columns theta Iobs Icalc. If Iobs is missing, the column is omitted.
|
|
Change displacement correction .
|
|
Change transparency correction .
|
|
Set the energy of the experiment [in keV, lambda(A)=12398/E(keV)].
|
|
Set the maximum value for sin(theta)/lambda. All data (reflections,..) still exist but are ignored for all calculations. |
|
Set observed powder pattern from vector array. Note: powder pattern parameters must have been set before calling this function, for example by calling DiffractionDataPowder::InitPowderPatternPar(). |
|
the powder pattern angular range & resolution parameter. this will affect all components (phases) of the pattern. Use this with caution, as the number of points must be correct with respect to the observed data (Iobs).
|
|
Set the x coordinate of the powder pattern : either the 2theta or time-of-flight values for each recorded point. The step need not be constant, but the variation must be strictly monotonous. 2theta must be in radians and time-of-flight in microseconds |
|
Set the radiation.
|
|
Set the radiation type.
|
|
Set sigma=sqrt(Iobs).
|
|
Set the wavelength of the experiment to that of an X-Ray tube.
NOTE : if the name of the wavelength is generic (eg"Cu"), then the program considers that there are both Alpha1 and Alpha2, and thus automatically changes the WavelengthType to WAVELENGTH_ALPHA12. If instead either alpha1 or alpha2 (eg "CuA1") is asked for, the WavelengthType is set to WAVELENGTH_MONOCHROMATIC. In both cases, the radiation type is set to X-Ray. |
|
Set the wavelength of the experiment (in Angstroems).
|
|
Set w = 1/(a+ Iobs + b*Iobs^2+c*Iobs^3). To filter too small or null intensities: if Iobs < [minRelatIobs * max(Iobs)], then use Iobs=minRelatIobs * max(Iobs) to compute the weight. Typical values: a=2*min(Iobs) b=2/max(Iobs) c=0 |
|
Set w = 1/sigma^2. To filter too small or null intensities :If sigma< minRelatSigma* max(sigma), then w=1/(minRelatSigma* max(sigma))^2 |
|
Set w = 1.
|
|
Change Zero in x (2theta,tof).
|
|
Convert sin(theta)/lambda to pixel, depending on the type of radiation. This does not take into account any zero/transparency, etc... correction |
|
Convert sin(theta)/lambda to X (i.e. either to 2theta or to TOF), depending on the type of radiation. This does not take into account any zero/transparency, etc... correction |
|
Get the pixel number on the experimental pattern, corresponding to a given (experimental) x coordinate.
|
|
Get the pixel number on the experimental pattern, from the theoretical (uncorrected) x coordinate, taking into account all corrections. (zero, transparency,..). For internal use only.
|
|
Convert X (either 2theta or TOF) to sin(theta)/lambda, depending on the type of radiation. This does not take into account any zero/transparency, etc... correction |
|
Get the experimental x (2theta, tof) from the theoretical value, taking into account all corrections (zero, transparency,..).
For internal use only.
|
|
Input From stream.
Reimplemented from ObjCryst::RefinableObj. |
|
Output to stream in well-formed XML.
Reimplemented from ObjCryst::RefinableObj. |
|
Displacement correction : .
|
|
Transparency correction : .
|
|
|
|
The cumulative Chi^2 (integrated or not, depending on the option).
|
|
This is the logarithm of the part of log(Likelihood) which corresponds to the normalization terms of gaussian distribution for each obs/calc point. In practice, this is the sum of 1/2*log(2pi*sig(i)^2), although we discard the 2pi terms. |
|
Clock the last time Chi^2 was computed.
|
|
|
|
Clock recording the last time the number of points used (PowderPattern::mNbPointUsed) was changed.
|
|
When was the powder pattern last computed ?
|
|
When was the powder pattern (integrated) last computed ?
|
|
When were the pattern parameters (2theta or time-of-flight range) changed ?
|
|
When were the radiation parameter (radiation type, wavelength) changed ?
|
|
Corrections to 2Theta.
|
|
Last modification of the scale factor.
|
|
Time Of Flight (TOF) parameters : .
|
|
Time Of Flight (TOF) parameters : .
|
|
Max coordinate for 2theta for all excluded regions.
|
|
Min coordinate for for all excluded regions.
|
|
Used to fit the components' scale factors.
|
|
Used to fit the components' scale factors.
|
|
Used to fit the components' scale factors.
|
|
|
|
|
|
|
|
|
|
|
|
|
|
Is the mX vector sorted in ascending order ? (true for 2theta, false for TOF).
|
|
Maximum sin(theta)/lambda for all calculations (10 by default). This keeps all data in memory, but only the part which is below the max is calculated. |
|
Number of integration intervals actually used, due to the maximum value of sin(theta)/lambda.
|
|
Number of points in the pattern.
|
|
Number of points actually used, due to the maximum value of sin(theta)/lambda.
|
|
Use Integrated profiles for Chi^2, R, Rwp...
|
|
The calculated powder pattern part which corresponds to 'background' (eg non-scalable components). It is already included in mPowderPatternCalc |
|
The calculated powder pattern part which corresponds to 'background' (eg non-scalable components), integrated.
|
|
The calculated powder pattern. It is mutable since it is completely defined by other parameters (eg it is not an 'independent parameter') |
|
The components (crystalline phases, background,...) of the powder pattern.
|
|
The calculated powder pattern, integrated.
|
|
The observed powder pattern.
|
|
The sigma of the observed pattern.
|
|
The complete variance associated to each point of the powder pattern, taking into account observation and model errors.
|
|
The complete variance associated to each point of the powder pattern, taking into account observation and model errors. Integrated. |
|
The weight for each point of the pattern.
|
|
|
|
The Radiation corresponding to this experiment.
|
|
|
|
For internal use only. To compute scale factors, which are the components (phases) that can be scaled ? |
|
The scale factors for each component. For unscalable phases, this is set to 1 (constant). This is mutable because generally we use the 'best' scale factor, but it should not be... |
|
Should Statistics (R, Rw,..) exclude the background ?
|
|
Use faster, less precise functions ?
|
|
Vector of x coordinates (either 2theta or time-of-flight) for the pattern. Stored in ascending order for 2theta, and descending for TOF, i.e. always in ascending order for the corresponding sin(theta)/lambda. |
|
Zero correction : Thus mPowderPattern2ThetaMin=(mPowderPattern2ThetaMin-m2ThetaZero).
|