tgcd: Thermoluminescence glow curve deconvolution (TGCD)

Description Usage Arguments Details Value Note References See Also Examples

Description

Thermoluminescence glow curve deconvolution according to the general-order empirical expression or the semi-analytical expression derived from the one trap-one recombination (OTOR) model based on the Lambert's W function.

Usage

1
2
3
4
tgcd(Sigdata, npeak, inis = NULL, mwt = 90, 
     mdt = 3, nstart = 30, model=c("g", "lw"), 
     elim = NULL, logy = FALSE, hr = NULL, 
     outfile = NULL, plot = TRUE)

Arguments

Sigdata

matrix(required): a two-column matrix, temperature values and thermoluminescence signal values are stored in the first and second column, respectively

npeak

integer(required): number of glow peaks, the allowed maximum number of glow peaks is set equal to 13

inis

matrix(optional): a npeak-row 4-column matrix used for storing starting parameters Im, E, Tm, b (or R). If inis=NULL, the user has to click with a mouse on a plot to locate each glow peak maximum

mwt

numeric(with default): allowed maximum total half-width of deconvoluted glow peaks. A smaller mwt prevents the appearance of glow peaks with large total half-width. A conservative mwt is adopted by default

mdt

numeric(with default): allowed minimum distance between each optimized temperature at maximum thermoluminescence intensity. A larger mdt prevents the appearance of strongly overlapping peaks. A conservative mdt is adopted by default

nstart

integer(with default): number of trials, if nstart>1, a "try-and-error" protocol will be performed, the upper limit for nstart is set equal to 10000

model

character(with default): "g" means fitting a general-order model, "lw" means fitting the Lambert W-function, default model="g"

elim

vector(with default): lower and upper limits for the activation energy, default elim=c(0.5, 5)

logy

logical(with default): draw the y-axis of the plot used for locating peak maxima with a logarithmic scale or not

hr

numeric(optional): the linear heating rate used for calculating the frequency factor

outfile

character(optional): if specified, fitted signal values for each glow peak will be written to a file named "outfile" in CSV format and saved to the current work directory

plot

logical(with default): draw a plot according to the fitting result or not

Details

Function tgcd is used for deconvolving thermoluminescence glow curves according to the general-order empirical expression (Kitis et al., 1998; Pagonis et al., 2006) or the semi-analytical expression derived from the one trap-one recombination (OTOR) model based on the Lambert's W function (Kitis and Vlachos, 2013; Sadek et al., 2015; Kitis et al., 2016) using the Levenberg-Marquardt algorithm (plus supports for constraining and fixing parameters).

The general-order empirical expression for a glow peak is:

I(T)=Im*b^(b/(b-1))*expv*((b-1)*(1-xa)*(T/Tm)^2*expv+Zm)^(-b/(b-1))
xa=2*k*T/E
xb=2*k*Tm/E
expv=exp(E/(k*T)*(T-Tm)/Tm)
Zm=1+(b-1)*xb

where b is the kinetic parameter (lies between 1 and 2), I is the glow peak intensity, E the activation energyin ev, k the Boltzmann constant in eV/k, T the temperature in K with constant heating rate K/s, Tm the temperature at maximum thermoluminescence intensity in K, and Im the maximum intensity. The four parameters for this model are: Im, E, Tm, and b.

The semi-analytical expression derived from the one trap-one recombination (OTOR) model based on the Lambert's W function is:

I(T)=Im*exp(-E/(k*T)*(Tm-T)/Tm)*(W(Zm)+W(Zm)^2)/(W(Z)+W(Z)^2)
Zm=R/(1-R)-log((1-R)/R)+E*exp(E/(k*Tm))/(k*Tm^2*(1-1.05*R^1.26))*F(Tm,E)
Z=R/(1-R)-log((1-R)/R)+E*exp(E/(k*Tm))/(k*Tm^2*(1-1.05*R^1.26))*F(T,E)
F(Tm,E)=Tm*exp(-E/(k*Tm))+E/k*Ei(-E/(k*Tm))
F(T,E)=T*exp(-E/(k*T))+E/k*Ei(-E/(k*T))

where W(x) is the wright Omega function for variable x, Ei(x) is the exponential integral function for variable x, I is the glow peak intensity, E the activation energy in eV, k the Boltzmann constant in eV/K, T the temperature in K with constant heating rate in K/s, Tm the temperature at maximum thermoluminescence intensity in K, and Im the maximum intensity. The four parameters for this model are: Im, E, Tm, and R. The Fortran 90 subroutine used for evaluating the Wright Omega function is transformed from the Matlab code provided by Andrew Horchler available at https://github.com/horchler/wrightOmegaq.

The procedure minimizes the objective:

fcn=∑_{i=1}^n |y_i^o-y_i^f|, i=1,...,n

where y_i^o and y_i^f denote the i-th observed and fitted signal value, respectively, and n indicates the number of data points.

Starting parameters (inis) can be specified by the user through argument inis or by clicking with a mouse on the plot of the thermoluminescence glow curve showing peak maxima if inis=NULL.The Levenberg-Marquardt algorithm (More, 1978) (minpack: Original Fortran 77 version by Jorge More, Burton Garbow, Kenneth Hillstrom. Fortran 90 version by John Burkardt freely available at http://people.sc.fsu.edu/~jburkardt/f_src/minpack/) was modified so as to supports constraints and fixes of parameters. If argument nstart>1, a "try-and-error" protocol with starting values generated uniformly around the given starting values inis will be performed repeatedly to search the optimal parameters that give a minimum Figure Of Merit (FOM) value.

Parameters can be interactively constrained and fixed by modifying the following elements in a automatically generated Dialog Table if inis=NULL:
(1) INTENS(min, max, ini, fix): lower and upper bounds, starting and fixing values of Im
(2) ENERGY(min, max, ini, fix): lower and upper bounds, starting and fixing values of E
(3) TEMPER(min, max, ini, fix): lower and upper bounds, starting and fixing values of Tm
(4) bValue(min, max, ini, fix): lower and upper bounds, starting and fixing values of b

Value

Return a list containing the following elements:

pars

optimized parameters stored in a matrix

ff

calculated frequency factor if hr!=NULL

sp

parameters used for describing the shape of a glow peak, see function simPeak for details

FOM

minimized Figure Of Merit

Note

The model to be optimized should not be underdetermined. This means that the number of data points should exceed the number of parameters. A lack of background counts in the analyzed data is assumed. To obtain reliable estimate, the presented background may be accounted for by subtracting from measured data before analysis.

References

Kitis G, Gomes-Ros JM, Tuyn JWN, 1998. Thermoluminescence glow curve deconvolution functions for first, second and general orders of kinetics. Journal of Physics D: Applied Physics, 31(19): 2636-2641.

Kitis G, Polymeris GS, Sfampa IK, Prokic M, Meric N, Pagonis V, 2016. Prompt isothermal decay of thermoluminescence in MgB4O7:Dy, Na and LiB4O7:Cu, In dosimeters. Radiation Measurements, 84: 15-25.

Kitis G, Vlachos ND, 2013. General semi-analytical expressions for TL, OSL and other luminescence stimulation modes derived from the OTOR model using the Lambert W-function. Radiation Measurements, 48: 47-54.

More JJ, 1978. "The Levenberg-Marquardt algorithm: implementation and theory," in Lecture Notes in Mathematics: Numerical Analysis, Springer-Verlag: Berlin. 105-116.

Pagonis V, Kitis G, Furetta C, 2006. Numerical and practical exercises in thermoluminescence. Springer Science & Business Media.

Sadek AM, Eissa HM, Basha AM, Carinou E, Askounis P, Kitis G, 2015. The deconvolution of thermoluminescence glow-curves using general expressions derived from the one trap-one recombination (OTOR) level model. Applied Radiation and Isotopes, 95: 214-221.

Further reading

Bos AJJ, Piters TM, Gomez Ros JM, Delgado A, 1993. An intercomparison of glow curve analysis computer programs: I. Synthetic glow curves. Radiation Protection Dosimetry, 47(1-4), 473-477.

Chung KS, Choe HS, Lee JI, Kim JL, Chang SY, 2005. A computer program for the deconvolution of thermoluminescence glow curves. Radiation Protection Dosimetry, 115(1-4): 345-349. Software is freely available at http://physica.gsnu.ac.kr/TLanal.

Harvey JA, Rodrigues ML, Kearfott JK, 2011. A computerized glow curve analysis (GCA) method for WinREMS thermoluminescent dosimeter data using MATLAB. Applied Radiation and Isotopes, 69(9):1282-1286. Source codes are freely available at http://www.sciencedirect.com/science/article/pii/S0969804311002685.

Kiisk V, 2013. Deconvolution and simulation of thermoluminescence glow curves with Mathcad. Radiation Protection Dosimetry, 156(3): 261-267. Software is freely available at http://www.physic.ut.ee/~kiisk/mcadapps.htm.

Puchalska M, Bilski P, 2006. GlowFit-a new tool for thermoluminescence glow-curve deconvolution. Radiation Measurements, 41(6): 659-664. Software is freely available at http://www.ifj.edu.pl/dept/no5/nz58/deconvolution.htm.

See Also

simPeak; simqOTOR

Examples

 1
 2
 3
 4
 5
 6
 7
 8
 9
10
11
12
13
14
15
16
17
18
19
20
21
# Load the data.
  data(Refglow)

# Deconvolve Refglow002 with 4 peaks using the Lambert W-function.
  startingPars <- 
  cbind(c(400, 550, 850, 1600), # Im
        c(1.4, 1.5, 1.6, 2),    # E
        c(420, 460, 480, 510),  # Tm
        c(0.1, 0.1, 0.1, 0.1))  # R
  tgcd(Refglow$Refglow002, npeak=4, model="lw",
       inis=startingPars, nstart=10)

# Do not run.
# Deconvolve Refglow009 with 9 peaks using the general-order equation.
# startingPars <- 
# cbind(c(9824, 21009, 27792, 50520, 7153, 5496, 6080, 1641, 2316), # Im
#       c(1.24, 1.36, 2.10, 2.65, 1.43, 1.16, 2.48, 2.98, 2.25),    # E
#       c(387, 428, 462, 488, 493, 528, 559, 585, 602),             # Tm
#       c(1.02, 1.15, 1.99, 1.20, 1.28, 1.19, 1.40, 1.01, 1.18))    # b
# tgcd(Refglow$Refglow009, npeak=9, model="g",
#      inis=startingPars, nstart=10)

ElsevierSoftwareX/SOFTX-D-15-00066 documentation built on May 6, 2019, 3:25 p.m.