Master'S Thesis: Rapid and Robust Fitting of Cole-Cole Models To Electrical Permittivity Spectra
Master'S Thesis: Rapid and Robust Fitting of Cole-Cole Models To Electrical Permittivity Spectra
Master'S Thesis: Rapid and Robust Fitting of Cole-Cole Models To Electrical Permittivity Spectra
Robin Mäki
2014
Robin Mäki
The dielectric properties of materials plays an important role in many fields, these prop-
erties can be described by the Cole-Cole parameters. In this thesis an automated method
for fitting of the Cole-Cole model to relative permittivity spectrum has been developed.
Two different iterative estimation techniques were implemented and analyzed based on
their performance. The implemented techniques were the Levenberg-Marquardt method
and the variable projection method.
One of the main difficulties with implementing an automated estimation method is the
need for good initial values. The variable projection method factorizes the Cole-Cole
equation into a linear and non-linear part. By doing this the problem can be reduced
down from a five dimensional problem into a problem only depending on the two non-
linear parameters. The reduction in dimensionality makes it viable to find initial values
by performing a grid search.
A Monte-Carlo simulation was part in the validation and comparison of the methods.
The result from this was that the variable projection method was more time consuming
but were able to obtained tighter uncertainty bounds for all of the parameters and a
smaller mean square error for the fitted curves.
The methods were applied to a data set containing measurements of the relative permit-
tivity of 15 crude oils. The result from this was consistent with that of the Monte-Carlo
simulation. The variable projection method obtained better fitting curves and smaller
mean square error for all oils.
iii
P REFACE
The making of this thesis concludes the fifth and final year of study for my Master’s
degree in Engineering Physics and Electrical Engineering at Luleå University of Technol-
ogy.
I would like to take the opportunity to thank Prof. Johan Carlson and Prof. Inge
Söderkvist for their support and encouragement throughout the project. I am also very
thankful to Kjetil Folgerø and Christian Michelsen Research AS for providing the mea-
surement data and valuable feedback.
Finally, a special thanks to my family for their encouragement and support during
these five years.
v
C ONTENTS
Chapter 1 – Introduction 1
1.1 Goal . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . 1
1.2 Related work/Literature study . . . . . . . . . . . . . . . . . . . . . . . . 2
1.3 Thesis structure . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . 3
1.4 Frequently used variables . . . . . . . . . . . . . . . . . . . . . . . . . . . 4
Chapter 2 – Theory 7
2.1 Permittivity and dielectric materials . . . . . . . . . . . . . . . . . . . . . 7
2.2 The method of least squares . . . . . . . . . . . . . . . . . . . . . . . . . 13
2.3 Method . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . . 15
2.4 The Levenberg-Marquardt algorithm . . . . . . . . . . . . . . . . . . . . 15
2.5 The variable projection method . . . . . . . . . . . . . . . . . . . . . . . 17
viii
C HAPTER 1
Introduction
The Cole-Cole equation [1], is a relaxation model often used to model relative permit-
tivity, εr . The model parameters describe dielectric properties that, in combination with
other metrics, are used when characterizing crude oils, [2]. The measured relative per-
mittivity is a complex valued quantity that is dependent on the (angular) frequency, ω
[rad/s]. Current research aims at developing methods for automatic measurement of the
dielectric parameters, using a wide range of frequencies. Fitting the Cole-Cole model to
the measured relative permittivity spectrum is done by adjusting the unknown param-
eters. Since the size of the Cole-Cole parameters varies by several orders of magnitude
the estimation problem is ill-conditioned. Hence, the parameter estimation is sensitive
to experimental noise. In order to assure decent to global minimum good initial guesses
of the parameters needs to be available. Furthermore, in order for the method to be of
practical use in an online setup it has to be automated, robust and reasonably fast.
1.1 Goal
The primary objective for this thesis is to:
• Develop and implement a rapid and robust estimation technique for fitting of Cole-
Cole models to relative permittivity measurements.
1
2 Introduction
T
- Matrix transpose.
†
- The Moore-Penrose generalized inverse.
∗
- Indicates the solution to an equation.
∇ - The Nabla operator.
⊥
- Denotes projection to an orthogonal subspace.
C HAPTER 2
Theory
This section will give the reader an introduction to the theoretical framework used in
this thesis. A introduction of permittivity, [16, ch. 5], and the Cole-Cole model, [1], will
be presented followed by theory regarding techniques and methods used to perform the
curve fitting, [17, 18]. The main focus will lay on two different curve fitting techniques,
the Levenberg-Marquardt method, [11, 12], and the Variable projection method [14].
Figure 2.1: Schematic description of an electric dipole, in this case a hydrogen fluoride
molecule. A separation of charge is present with negative charge to the right (red shade),
and positive charge to the left (blue shade).
7
8 Theory
If an electric field were to be applied to a dielectric, the electric charges in the material
would shift from their average equilibrium position causing dielectric polarization. An
easy way to visualize this is by using the classical approach to the dielectric model. That
is, each material is made up of atoms and each atom has a positive charge at its core.
The positive charge is surrounded by a negatively charged cloud consisting of electrons.
By applying an electric field the negatively charged cloud will be temporarily distorted
as long as the field is applied, see Figure 2.2.
Figure 2.2: Schematic description of the interaction between an applied electric field and
an atom.
Figure 2.3: Schematic of the polarization effects when an electric field is applied to a
dipole.
Similarly the same thing will happen when considering a material consisting of more
than one single dipole.
Figure 2.4: Schematic of the polarization effects when an electric field is applied to a
dielectric.
The shift of positive charges will be towards the field and the negative charges will
shift in the opposite direction. This shift of the charged particles will also create an
internal electric field that reduces the overall field within the dielectric. The dielectric
medium both affect and is affected by the electric field and a measure of these affects is
the absolute permittivity.
As shown, the presence of an electric field in a dielectric material causes the bound
charges in the material to slightly separate, see Figure 2.2. The electric displacement
field, D, describes how the presence of an electric field, E, affects the orientation of the
electric charges and is defined as
D ≡ ε0 E + Pd , (2.1)
where Pd is the polarization density, an entity that describes the induced dipole moment
in the material. The constant ε0 is the permittivity in vacuum and is defined as
10 Theory
def 1
ε0 = ≈ 8.854 · 10−12 [F/m], (2.2)
c20 µ0
where c0 is the speed of light in vacuum and µ0 is the permeability in vacuum, i.e.
the ability of the material to support the formation of a magnetic field within itself.
In a dielectric that is linear, isotropic, nondispersive, and homogeneous, and respond
instantaneous to a change in the electric field, the polarization density depends linearly
on the electric field,
Pd = ε0 χE. (2.3)
Here χ is a dimensionless constant called electric susceptibility and indicates the di-
electrics degree of polarization in response to an applied electric field. The electric sus-
ceptibility is directly related to the relative permittivity, εr = ε/ε0 , by
ε
χ = εr − 1 = − 1. (2.4)
ε0
Hence, the electric displacement field can be expressed as
ε
D = ε0 E + Pd = ε0 E + ε0 χE = ε0 E (1 + χ) = ε0 E 1 + − 1 = εE. (2.5)
ε0
In dispersive dielectric mediums the polarization of the charged particles, due to an
applied electric field, cannot happen immediately. Hence the relation between P d and E
is dynamic. If an arbitrary electric field is applied at time t = 0, the polarization density
can be expressed as a superposition of the effects of E(t0 ) for all t0 ≤ t. That is
Zt
Pd (t) = ε0 χ(t − t0 )E(t0 )dt0 . (2.6)
−∞
The polarization density is time dependent and obtained by calculating the convolution
of the impulse response susceptibility and the electric field. The convolution theorem,
[16, p.1129], makes it possible to move a convolution in time domain to a point wise
product of Fourier transforms in frequency domain it is therefore convenient to take the
Fourier transform and write the function as a function of frequency as.
most be casual. This causality can be represented by a phase difference. Since complex
numbers allow specification of magnitude and phase, the permittivity is usually treated
as a complex function dependent on angular frequency. This allows permittivity to be
defined as
J d = σE, (2.11)
which is a form of Ohm’s law, [16, p.758]. Combining (2.10) with (2.11) gives
σ
J tot = jωD + σE = jω(ε + )E. (2.12)
jω
σ
That is, if the medium is lossy the extra term jω needs to be taken into account. It
should be noted that the term varies inversely with frequency and hence the contribution
of the conductive component decreases as the frequency increases.
The electromagnetic energy absorbed by dielectrics does in general depend on a few
different mechanisms which in turn affect shape of the permittivity spectrum. There are
resonance effects that can arise from the vibration or rotation of the electrons, atoms
or ions. These can be observed in the area around their absorption frequencies. There
are also relaxation effects. The field changes slowly at low-frequencies and this allows
the dipoles to reach equilibrium before the field has a measurable change. At higher
frequencies and due to the viscosity of the medium, the dipoles cannot always follow
the changes in the allied field and an energy loss will occur due to the absorption of the
12 Theory
fields energy. For ideal dipoles the dielectric relaxation can be described by the Debye
relaxation model, [19].
The Debye equation is used to describe the relaxation response of a group of ideal
noninteracting dipoles to an applied altering electric field. The Debye relaxation equation
given below describes the complex relative permittivity of the medium as a function of
the frequency, ω, of the applied electric field
εs − ε∞
εb(ω) = ε∞ + , (2.13)
1 + jωτ
where ω is the angular frequency, εs = lim εb(ω) is the static permittivity, ε∞ = lim εb(ω)
ω→0 ω→∞
is the high-frequency permittivity and τ is the relaxation time of the dipole.
In 1941 the brothers Kenneth and Robert Cole developed a variant of the Debye equa-
tion. It is
εs − ε∞ σ
εb(ω) = ε∞ + 1−α
+j , (2.14)
1 + (jωτ ) ωε0
which is called the Cole-Cole equation, [1]. The last term in 2.14 is added in the case
of a lossy medium. The main differences between the models is that the Cole-Cole
model uses a relaxation time distribution and that the parameter τ here is the central
relaxation time. The model includes an exponent 1 − α, which describes the broadness
of the relaxation time distribution. It is bounded by 0 ≤ α ≤ 1. When the exponent
becomes smaller the relaxation time distribution becomes broader. This means that
the transition between the low- and the high-frequency values becomes wider, and the
peak on the imaginary part of the spectrum becomes wider. The Cole-Cole model can
be viewed as a superposition of multiple Debye models. The central relaxation time
is an inverse of the frequency corresponding to peak position on the imaginary part of
spectrum.
It should be noted that the model assumes that the dielectric dispersion curve is sym-
metric and that both the Debye and the Cole-Cole equation given here describes the
complex relative permittivity, εr = ε/ε0 . The models are based on relative permittivity
because it is usually what is measured.
Measurements of the relative permittivity can be obtained by measuring the capaci-
tance between two plates separated by a distance l. By first measuring the capacitance
with vacuum in between the plates, C0 , and then measure the capacitance with the di-
electric in between the plates, Cl . The quota between these two measurements will be
the same as the quota between the absolute permittivity and the permittivity in vacuum,
that is, the relative permittivity.
Cl ε
= = εr . (2.15)
C0 ε0
2.2. The method of least squares 13
of the squared residuals is minimized. Here || · || is the Euclidean norm and the residual,
ri (p) = f (p; xi )−yi , is the difference between the model at the points xi and the measured
spectrum. It is clear that both S and r are functions of p although from now on we will
suppress that in the notation for the sake of clarity.
The minimum of the sum S in (2.16) is found when the gradient vector is zero, if it
is not zero then there is a direction in which we can move to minimize it further. By
differentiating S with respect to the unknown parameters p and setting the result to
zero, the minimum of S can be found.
Linear least squares, [17, ch.10.2], is a least squares method used for fitting data to a
model which is linear in the unknown parameters. If the function, f (p; x), is linear then
the residual vector can be written as r = Xp − y, where X is a m × n matrix of linear
equations. Hence, the linear least squares problem is
1
min ||Xp − y||. (2.17)
p 2
X T X p∗ = X T y,
(2.18)
Nonlinear least squares, [17, ch.10.3], fits data to models that are nonlinear in the
unknown parameters. But since the model and hence also the residual is nonlinear the
derivatives are functions of both the independent variable, x, and the parameters, p.
This means that usually there is no closed solution to the gradient equations,
∂S
= 0. (2.19)
∂pj
A common method used to solve nonlinear least squares problem is the Gauss-Newton
method. The method can, given an initial guess, find the parameters by successive
iterations. At each iteration the estimated parameters will be refined, accordingly
2.3 Method
Since the Cole-Cole equation, (2.14), is nonlinear in some of the unknown parameters
the method of nonlinear least squares will be used for the curve fitting. Two different
curve fitting techniques will be compared. One being the Levenberg-Marquardt method.
The other method is the Variable projection method, which takes into account some of
the characteristics of the Cole-Cole equation. Both the Levenberg-Marquardt and the
variable projection method makes use of the Gauss-Newton algorithm derived in the
previous section. It should be noted that quantities with subscript 1 or 2 denotes that
the quantity is specific for the Levenberg-Marquardt and variable projection method
respectively.
1 (k) (k)
minm ||J 1 h + r 1 ||22 s.t.||h||2 ≤ ∆(k) . (2.26)
h∈< 2
Here ∆(k) is the radius of the trust region. It can be shown, [17, ch.4], that the solution,
h(k)∗ , to
(k)T (k) (k)T (k)
J1 J 1 + λ(k) I h(k)∗ = −J 1 r 1 , (2.27)
(k)T (k)
where I is the identity matrix and λ(k) is a scalar such that the matrix J 1 J 1 + λ(k) I
is positive semi-definite, solves the subproblem (2.26) if either ||h||2 = ∆ and λ ≥ 0 or
||h||2 ≤ ∆ and λ = 0. This method is known as the Levenberg-Marquardt method.
It should be noted that if ∆ is large enough the solution to (2.27) is found when λ = 0.
That is, (2.27) becomes the Gauss-Newton algorithm, see (2.23). It should also be noted
that when λ → +∞, ||h||2 → 0 and h becomes parallel to the search direction of the
steepest descent method, [20, pp.102-103]. That is, it approaches the direction of the
negative gradient
(k)T (k)
h(k)∗ = −J 1 r1 . (2.28)
An updated relationship where the identity matrix I in (2.27) is replaced with the
(k)T (k)
diagonal elements of the J 1 J 1 matrix was suggested by Marquardt, [12]. Using this
relationship the search direction is computed by solving
(k)T (k) (k)T (k) (k)T
J1 J 1 + λ(k) diag(J 1 J 1 ) h(k)∗ = J 1 r. (2.29)
The advantage of this is that each component of the gradient will now be scaled according
to the curvature. Hence, there will now be larger movement along the directions where
the gradient is smaller. This avoids slow convergence in the direction of small gradient.
A good value of the trust region radius, ∆, and the damping parameter λ needs to
be chosen in order to ensure descent. Since the two parameters are related, choosing
one is equivalent to choosing the other. The choice can either be done by adjusting the
damping parameter directly, or, by first choosing an acceptable step size and then finding
a λ such that ||h|| ≤ ∆. Here the focus will be on λ. There are many different methods
available that can be used for this, but usually it is adequate to use the simple method
suggested by Marquardt, in which λ is either increased by a fixed factor λup or decreased
by a fixed factor λdn . Different sets of values will be more suitable for different types
of problems, but it is often sufficient to use λup = λdn = 10. Whether or not λ will be
increased or decreased depends in turn on the change between the model function and
the cost-function. Given the current and previous step a scalar ρ, [17, p.68], is defined as
2.5. The variable projection method 17
S (k) − S (k+1)
ρ(k) = . (2.30)
φ(k) (0) − φ(k) (h)
Depending on the value of ρ there are a few things that should be noted. The predicted
reduction should always be nonnegative since the step h is obtained by minimizing φ(k)
over a region that includes h = 0. Thus, if ρ(k) is negative, that means that the cost-
function is increasing, S (k+1) > S (k) , and the step most be rejected. If, on the other
hand, ρ(k) is larger than some threshold ν > 0 it means that the model at the current
step is consistent with the function and hence the trust region can be expanded for the
next iteration. Similarly if ρ(k) is smaller than the threshold it means that the model is
not consistent with the function at the current step and the trust region is reduced to
the next iteration.
To summarize
y = A(b)a, (2.31)
where A is called the model matrix and is a function of b and x. The fitting problem is
a nonlinear least squares problem and the goal is to find the values of the parameters a
and b by solving
1
min ||y − A(b)a||22 . (2.32)
a,b 2
From (2.32) it is clear that, given a value of b, the linear parameters a can be calculated
using the linear least squares, (2.18). The estimate of the linear parameter is thus given
by
where A† (b) denotes the Moore-Penrose generalized inverse of A(b) which will be used
henceforth for notational simplicity. It will from here on, also be assumed that the model
matrix A is a full rank <m×n1 matrix, where m > n1 , for all b.
Let us now define a projection matrix P (b) and a projection matrix P ⊥ (b) that projects
a vector onto the range of A(b) and onto the null space of AT (b) respectively. The
projection matrix P (b) will be defined as
As seen from the equation above the residual becomes a function of b, r 2 = r 2 (b) =
P ⊥ (b)y. Combining this with (2.32) results in
1 ⊥ 2
min P (b)y 2 . (2.37)
b 2
The linear parameters has been removed and we are left with a nonlinear least squares
problem that needs to be solved in order to find b. Introducing the function q(b) = 21 r T2 r 2
the original problem (2.32) can be separated into two least squares problem
1 2
min y − A(b)a , (2.39)
b
2
a 2
where (2.38) is a nonlinear least squares problem whose solution, b b, is needed as input to
the linear least squares problem (2.39). The technique developed by Golub and Pereyra,
[14], a useful for solving this problem. The technique is based on applying Gauss-Newton
method, (2.23) - (2.24), to the variable projection functional, which is in essence the
squared norm of the residual, P ⊥ (b)y.
The developed method solves (2.38) by iteratively updating b as
−1
(k) (k)
b(k) = b(k−1) − γ H 2 g2 , (2.40)
where k is the iteration index, γ is the step length, H 2 and g 2 are the Hessian matrix
and the gradient of q(b) respectively. Both the vector gradient, defined as g 2 = J 2 r 2 (b),
2.5. The variable projection method 19
P i (b) = P i (b)P (b) + P (b)P i (b) = P ⊥ (b)Ai (b)A† (b) + (P ⊥ (b)Ai (b)A† (b))T . (2.47)
Using the result given by the equation above together with (2.35) gives that the partial
derivative of the projection matrix, P † (b), becomes
P⊥ ⊥ † ⊥ † T
i (b) = −P (b)Ai (b)A (b) − (P (b)Ai (b)A (b)) . (2.48)
20 Theory
Knowing that the Jacobian matrix is given by J 2 = ∇r 2 (b) = P ⊥ (b)y and applying
(2.33), its jth column becomes
This section covers some of the implementation of the Levenberg-Marquardt and the vari-
able projection method. Both methods were implemented specifically to fit the Cole-Cole
model, (2.14), to measured relative permittivity spectrum. In particular the calculation of
the Jacobian matrix, the selection of the initial guesses and the convergence criterion will
be covered. All code has been written in MATLAB and as in the previous section, quan-
tities with subscript 1 or 2 denotes that they are specific for the Levenberg-Marquardt
and variable projection method respectively.
21
22 Numerical implementation
∂b
ε jτ ω
= , (3.1)
∂ε∞ (jτ ω)α + jτ ω
∂b
ε 1
= , (3.2)
∂εs 1 + (jτ ω)(1−α)
∂b
ε α−1 εs − ε∞
= jω 2 , (3.3)
∂τ ((jτ ω)(1−α) + 1) (jτ ω)α
∂b
ε lnjτ ω (1−α)
= 2 (εs − ε∞ )(jτ ω) , (3.4)
∂α ((jτ ω) (1−α) + 1)
∂b
ε j
=− . (3.5)
∂σ ωε0
It should be noted that the Jacobian matrix in this case is a matrix of size m × 5, where
m is the number of data points.
−j ∞
1 1
f (a, b; ω) = 1− s , (3.6)
1 + (jωτ )1−α 1 + (jωτ )1−α ω0
| {z } σ
A(b) | {z }
a
where b = [τ, α]. The linear parameters in a can be calculated given a value of the
nonlinear parameters in b according to (2.33). Due to this, the problem has been reduced
from a five dimensional to a two dimensional problem. In (2.49) it is shown how the
ith column of the Jacobian matrix can be calculated. The only unknown is the term
Ai , which is the partial derivative of A(b), see (3.6), with respect to the parameter bi .
Since b = [b1 , b2 ] = [τ, α], the derivative of A(b) with respect to τ and α is needed.
Differentiating A(b) with respect, τ , gives the analytical expression
3.2. The initial guess 23
j(α − 1)ω(jτ ω)α
− α 2
((jτ ω) + jτ ω)
∂A(b)
α
= j(α − 1)ω(jτ ω) , (3.7)
∂τ
((jτ ω)α + jτ ω)2
0
whereas differentiating with respect to α gives
(jτ ω)α+1 ln(jτ ω)
− α 2
((jτ ω) + jτ ω)
∂A(b) (jτ ω)α+1 ln(jτ ω)
= . (3.8)
∂α
((jτ ω)α + jτ ω)2
0
The current estimate of the parameters τ and α are used as input.
Figure 3.1: Example of initial guess when cost-function only has one minima and the
function is only dependant on one parameter.
But using a uniform initial guesses in cases where the cost-function has multiple minima
there is a risk that the found minima is only a local and not the global minima. Hence,
the correct model parameter p has not been found. An example of this is shown in
Figure 3.2, one again the function is only dependant on one parameter.
Figure 3.2: Example of initial guess when cost-function has multiple minima and the
function is only dependant on one parameter.
As can be seen by the example given by Figure 3.2, good initial guesses are needed to
ensure that the global minima is found.
3.2. The initial guess 25
j
τ0 = , (3.11)
ωImax
where ωImax here represents the frequency at the point where the imaginary part of the
permittivity spectrum has its maximum value.
The parameter α represents the width of the dispersion area and is bounded between
[0, 1]. The initial guess is chosen as the midpoint in this interval, α0 = 0.5.
Lastly we consider the initial guess for the conductivity parameter σ. In Section 2.1
it was show that the conductivity was part of the extra term, jσ/ω, added in order to
account for the case of lossy mediums. From this term it is seen that σ will affect the
spectrum most at low frequencies. Hence, the initial guess for the conductivity will be
chosen as
σ0 = ωl ε0 = {ε(ωl )} , (3.12)
where ωl represents that the initial guess for the conductivity was calculated at low
frequency. The permittivity in vacuum, ε0 ≈ 8.854 · 10−12 [F/m], is part of the expression
since it is the relative permittivity that is used.
Figure 3.3 gives a graphical description of how the initial guess are chosen for the
Levenberg-Marquardt method.
26 Numerical implementation
Figure 3.3: Graphical description of how the initial guess is found using the Levenberg-
Marquardt method.
Note that the spectrum in Figure 3.3 was generated with the help of the Cole-Cole
model and hence does not contain any noise.
In this section the methods will be tested and compared against each other. The com-
parison will be based on computational speed and accuracy in finding the parameters.
Lastly the methods will be applied to real measurement data.
29
30 Simulation results
An example of a generated signal where AWGN with a SN RdB = 40 has been added
can be seen in Figure 4.1 below.
Figure 4.1: Example showing the generated curve (green) and the generated curve when
AWGN with SNR = 40 dB has been added (blue).
The Cole-Cole equation was fitted to each realization using both estimation techniques.
The grid used in the variable projection method, see Section 3.2.2, divided the parameter
interval of τ and α into 15 and 10 segments respectively. The interval for the relaxation
time was τ ∈ [10−12 , 10−5 ]. The methods used the same tolerance values for the conver-
gence criterion, see Section 3.3. If the change in cost-function, (3.14), is smaller than
µ1 = 10−6 or the scaled parameter change, (3.15), is smaller than µ2 = 10−4 the algo-
rithms will terminate. If neither of these are met the algorithms will terminate after
reaching the maximum number of iterations kmax = 1000.
The Monte-Carlo simulation was used to calculate a two standard deviations (2SD)
confidence interval for each of the parameters. That is, the confidence interval indicates
that the parameters lies within 2SD of the mean. In Figure 4.2 the generated permittivity
spectrum is shown without noise together with the mean estimate and confidence interval
of the spectrum calculated using both the variable projection method and the Levenberg-
Marquardt method.
4.1. Validation of the two estimation techniques 31
Figure 4.2: Result from the Monte-Carlo simulation. The top and bottom left plots
are the real and imaginary part of the permittivity spectrum for the variable projection
method, respectively. The top and bottom right plots are the real and imaginary part
of the permittivity spectrum for the Levenberg-Marquardt method, respectively. The
green and blue solid lines represent the true and mean estimated permittivity spectrum,
respectively. The confidence interval is shown as dashed lines.
From the Figure 4.2 it seems like there are more uncertainties in the Levenberg-
Marquardt method, due to it having a wider confidence interval, than in the variable pro-
jection method. The corresponding parameters and their confidence interval are shown
in Table 4.1.
Table 4.1: Monte-Carlo simulation results. The computed parameters p∗ are shown with
a calculated 2SD confidence interval and the mean starting guess p0 for both methods.
The generated curve used the parameters displayed in the column True parameters.
From Table 4.1 it can be seen that the variable projection method had better (average)
initial guesses, i.e. closer to the true values, than the Levenberg-Marquardt method
whose initial guesses for especially τ and σ where poor.
The mean estimate of the parameters for both method are on the other hand quite
close to the true parameter values. The width of the confidence interval varies between
the parameters but the variable projection method had a tighter confidence interval in all
cases. For the variable projection method the estimates of εs and ε∞ are good, inside the
2SD confidence interval the estimated parameters are within 0.1%, respectively 0.3%,
from the true parameter value. The estimates for relaxation time, τ , and the distribution
factor, α, both had wider confidence intervals resulting in the estimates being within 16%,
respectively 4% from the true values. As seen from Table 4.1 the confidence interval for
σ were poor.
In combination with the results from Table 4.1 it is interesting to see how the parameters
affect the mean squared error (MSE). This was studied by generating a curve, y 1 , with
the parameters in (4.1). Another curve , y 2 , was generated using the same parameters
with the exception that ε∞ had been increased with 5%. The MSE between the two
curves was then calculated. The same thing was done for the four other parameters.
The result can be seen in the Table 4.2. As seen from Table 4.2 a 5% increase of the
MSE
ε∞ + 5% 3.5
εs + 5% 5.6
τ + 5% 3.5 · 10−4
α + 5% 6.9 · 10−3
σ + 5% 8.8 · 10−7
parameters τ , α and σ hardly affects the MSE at all. Whereas a 5 % increase of ε∞ and
especially εs have a huge affect on the MSE. Combining the result from Table 4.1 and 4.2
the overall conclusion is that the more the parameters affect the MSE the more accurate
the estimate of the parameters will be.
As seen from Table 4.2, σ has a small affect on the MSE. This is largely due to the
fact that the affect of σ on the spectrum is in the low frequency region of the imaginary
part. Extending the frequency range more in the low frequency region should give clearer
indication of the affect of σ and hence make it easier to estimate. This was confirmed
with a Monte-Carlo simulation where the lower end of the frequency interval was changed
from roughly ω = 105 to ω = 104 . The confidence interval for σ became a lot better for
both methods 2.4886 · 10−9 ± 0.2812 · 10−9 and 2.4807 · 10−9 ± 0.5615 · 10−9 for the variable
projection method and the Levenberg-Marquardt method respectively.
The increase of the frequency range had some affect the of the other parameters. For
4.1. Validation of the two estimation techniques 33
the variable projection method the estimate for εs and α became better, 2.3502 ± 0.0018
and 0.6030 ± 0.0208, whereas the estimate for ε∞ not experience any significant change.
The increase of the frequency range made the grid segments for τ a bit larger which had a
negative effect on the estimate 1.4304·10−8 ±0.3408·10−8 . To obtain the same coarseness
in the grid search the number of segments used in the first level of the hierarchy can be
increased.
The Levenberg-Marquardt method obtained overall better estimates after the lower end
of the frequency interval was changed than it did before the change. Notably the estimate
of τ , which became 1.5322 · 10−8 ± 1.2674 · 10−8 and the estimate of εs , which became
2.3505 ± 0.0091, likely due to the fact that better starting guesses could be obtained,
εs,0 = 2.3467.
During the first Monte-Carlo simulations some other quantities where also calculated
and can be seen in Table 4.3. Form Table 4.3 it should be noted that h is the parameter
Table 4.3: Quantities used for an extended comparison. All quantities below are averages
obtained from the Monte-Carlo simulation.
change and p is the current parameter estimate. The quantity ||h/p|| represents the
scaled parameter change during the last iteration and that the division is element wise.
As seen the average last step was smaller for the variable projection method. The average
MSE is also smaller for the variable projection method. It should be noted that poor
initial guesses might result in the methods only finding local minima, which would affect
the MSE.
The variable projection method had fewer iterations, better initial guesses is one likely
reason. The computation time was on the other hand longer due to the gird search being
time consuming. The gird search is responsible for about 40% of the computation time
for the variable projection method. As seen the variable projection method is overall
more time consuming than the Levenberg-Marquardt method.
The average number of iterations differ a lot between the methods. The Levenberg-
Marquardt method use an average of 374 iterations compared to about 4 for the variable
projection method. It should also be noted that in about 32% of the cases the Levenberg-
Marquardt method is terminated because the maximum number of iterations has been
reached. In contrast, the maximum number of iterations was never reached by the vari-
able projection method.
34 Simulation results
4.2.2 Result
In this section will only show the results for one of the crude oils, oil 1S. Results, in form
of plots and tables, for the 14 remaining oils can be seen in the appendix. It should be
noted that the same settings for the algorithms used in the Monte-Carlo simulation was
used here. Since it is unknown if the conductivity parameter, σ, should be included in the
Cole-Cole equation, (2.14), both versions of the model were applied and the one resulting
in the smallest MSE was chosen. Figure 4.3 below displays the measured permittivity
spectrum of the oil (dotted and blue) together with the fitted model (solid and red) for
both the variable projection method and the Levenberg-Marquardt method.
2.4 2.4
2.35 2.35
2.3 2.3
2.25 2.25
ℜ [ε]
ℜ [ε]
2.2 2.2
2.15 2.15
2.1 2.1
Measured Measured
2.05 Estimated 2.05 Estimated
6 7 8 6 7 8
10 10 10 10 10 10
Frequency [rad/s] Frequency [rad/s]
0.06 0.06
Measured Measured
0.05 Estimated 0.05 Estimated
0.04 0.04
0.03 0.03
ℑ [ε]
ℑ [ε]
0.02 0.02
0.01 0.01
0 0
−0.01 −0.01
6 7 8 6 7 8
10 10 10 10 10 10
Frequency [rad/s] Frequency [rad/s]
Figure 4.3: Real (top) and imaginary (bottom) part of the estimated and measured
relative permittivity spectrum for oil 1S. The estimated spectrum in the left hand plots
was obtained with the variable projection method and the estimated spectrum in the
right hand plots was obtained with the Levenberg-Marquardt method respectively.
As can be seen from Figure 4.3 there is a gap in the measurement data between the
36 Simulation results
high and low frequencies which is due to the change of measurement equipment. The gap
in the data may at times lead to a poor initial guess of τ for the Levenberg-Marquardt
method. This does not seem to be a problem in this case since the initial guesses of τ
are quite similar for both methods.
It can also be seen that for the most part the measurement noise is quite limited.
The majority of the noise seems to occur after the changing measurement equipment to
measure the higher frequencies and then especially at the imaginary part of the spectrum.
From Figure 4.3 it seems like the variable projection method provided a better fit of
the Cole-Cole model to the spectrum. Comparing the MSE of the methods, see MSE in
Table 4.5, it is seen that there is a significant difference, in favor of the variable projection
method. Comparing the initial guess with the final estimate of the parameters, see Table
4.4, for the variable projection method, one can see that the difference is small and hence
only one iteration was needed. It is also interesting to note that the variable projection
method deemed that the estimate was better when the σ parameter was neglected, hence
σ = 0. If the conduction current is negligible it would mean that the oil 1S not is a lossy
medium.
Table 4.4: The found parameters p∗ and the initial guesses p0 for oil 1S using the variable
projection method and the Levenberg-Marquardt method.
The conclusion from this is that the variable projection method did a better job of
fitting the Cole-Cole model to the measure spectrum of the oil 1S than the Levenberg-
Marquardt method did.
The accuracy of the initial guesses for the variable projection method is dependant
on the coarseness of the grid search. To study how the coarseness of the grid affected
4.2. Applying the models to real measurement data 37
the result for the variable projection method the coarseness was both increased and
decreased. The change of the coarseness was achieved by dividing the parameter interval
for τ and α into a different number of segments. Three different segment pairs were used
and the result can be seen in Table 4.6.
Table 4.6: Result from variable projection method with different coarseness of the grid.
The segment pair (x,y) means that the interval for τ and α was divided into x and y
segments respectively.
Variable projection
Segments (τ, α) (8, 5) (30, 20) (2000, 200)
ε∞ 2.1405 2.1288 2.1302
εs 2.2860 2.2895 2.2892
−8 −9
τ 1.1790 · 10 9.3337 · 10 9.6452 · 10−9
α 0.5343 0.5816 0.5772
σ 0 0 0
As can be seen from Table 4.6 changing the coarseness of the grid and hence also the
accuracy of the initial guesses results in the method finding different parameters. Table
4.7 shows the various quantities used for the comparison.
Table 4.7: Quantities used for extended comparison, variable projection method with
different grid coarseness of the grid.
Variable projection
Segments (τ, α) (8, 5) (30, 20) (2000, 200)
MSE 0.0105 0.0095 0.0095
−9 −4
||h/p|| 6.6303 · 10 2.8726 · 10 3.0921 · 10−4
Number of iterations 2 1 1
Computation time [s] 0.3350 0.7850 392
From Table 4.7 it can be seen that decreasing the number of segments for τ and α
from 15 and 10 to 8 and 5 respectively resulted in an increase of the MSE. Whereas
doubling the number of segments for τ and α from 15 and 10 to 30 and 20 respectively
resulted in a slight decrease of the MSE. This increase resulted in about a doubling of
the computation time. Increasing the number of segments further did not seem to have
any significant affect on the MSE.
Extending the comparison between the variable projection method and the Levenberg-
Marquardt method to include the 14 oils in the appendix the result is similar. The
38 Simulation results
variable projection method was able to provide a better fit in all cases. The result when
comparing the MSE was similarly as above, it is always significantly smaller for the
variable projection method. The Levenberg-Marquardt method had at times difficulties
with obtaining good initial guesses of τ , mostly in cases when there were no measurement
points for the maximum of the imaginary part.
C HAPTER 5
Discussion and conclusions
In this master thesis two estimation techniques, one based on the Levenberg-Marquardt
algorithm and the other on the variable projection method, were implemented. The
objective was to develop an automated method that in a quick and accurate manner can
estimate the parameters of the Cole-Cole model for relative permittivity.
Both methods are iterative and needs good initial guesses to ensure decent to the global
minima. An advantage with the variable projection method in this regard is that the
quality of the initial guesses is determined by the coarseness of the gird, hence largely
depends on what is deemed acceptable in regards of computational time.
When it comes to accurately estimate the parameters it is to be beneficial to factorize
the Cole-Cole model into a linear and non-linear part and hence reduce the problem
down from a 5-dimensional to a 2-dimensional problem. As seen from the result of the
Monte-Carlo simulation the accuracy of the variable projection method were better for
all parameters, see Table 4.1. Both methods had some difficulties obtaining accurate
estimations for of the relaxation time, τ , and the conductivity of the material, σ.
The difficulties with obtaining accurate estimations of τ were probably due to the small
affect the parameter has on the MSE compared to the other parameters, see Table 4.2.
On the other hand, the difficulties with estimating σ stemmed from the fact that the
used frequency range did not include lower frequencies. The affect that the conductivity
has on the spectrum is largely in the low-frequency region of the imaginary part. If the
frequency range does not include low enough frequencies the affects of σ will be difficult
to see, hence it will also be difficult to estimate its magnitude.
In regards to time consumption the Levenberg-Marquardt method were faster that
the variable projection method, whose the grid search was time consuming. The grid
search is largely dependent on the interval for τ . If it can be reduced then the number
of segments can be reduced and the computational time will be faster.
The variable projection method were more reliable than the Levenberg-Marquardt
method when it came to the real measurement data. It provided smaller MSE:s for
every oil and the estimated spectrum seemed to fit well with the measured spectrum.
39
C HAPTER 6
Future work
Some improvements to the algorithm has been considered and the most significant of
them are described here.
• The implementation of complex weights to the algorithm. This will allow the
algorithm to weight down noisier regions of the spectrum and thus limit the affect
this the noise has on the calculations.
• Implement the method using QR-decomposition would make it more robust. If e.g.
the Jacobian matrix, J , is poorly conditioned computing (J T J )−1 can be a source
of numerical rounding errors.
• If the medium is lossy the conductivity parameter, σ, should be included in the Cole-
Cole equation in order to account for the energy loss. Development of a method
for determining whether or not it should included in the Cole-Cole equation would
be beneficial since it would make sure a more accurate model is used.
• An extension of the algorithm could also be made to include some other relaxation
models like e.g. Debye, Cole-Davidson and Havriliak-Negami relaxation.
41
A PPENDIX A
Cole-Cole model fitted to
measured relative permittivity
spectrum of crude oils
This appendix will contain the results, in form of plots and tables, of when the variable
projection method and the Levenberg-Marquardt method was used to fit the Cole-Cole
equation to measured relative permittivity spectrum of crude oils. Two things should be
noted. Firstly, the conductivity, parameter, σ, at times can be excluded from the Cole-
Cole equation, (2.14). Therefore both versions were applied and the one resulting in the
smallest MSE was chosen. For this reason the conductivity parameter will in some cases
be σ = 0. Secondly, all the plots in this appendix contains four images. The top images
contain the real part of the permittivity spectrum and the bottom images contain the
imaginary part of the permittivity spectrum. The estimated spectrum in the left hand
plots were obtained with the variable projection method and the estimated spectrum in
the right hand plots were obtained with the Levenberg-Marquardt method respectively.
43
44 Appendix A
A.1 Oil 1S
2.4 2.4
2.35 2.35
2.3 2.3
2.25 2.25
ℜ [ε]
ℜ [ε]
2.2 2.2
2.15 2.15
2.1 2.1
Measured Measured
2.05 Estimated 2.05 Estimated
6 7 8 6 7 8
10 10 10 10 10 10
Frequency [rad/s] Frequency [rad/s]
0.06 0.06
Measured Measured
0.05 Estimated 0.05 Estimated
0.04 0.04
0.03 0.03
ℑ [ε]
ℑ [ε]
0.02 0.02
0.01 0.01
0 0
−0.01 −0.01
6 7 8 6 7 8
10 10 10 10 10 10
Frequency [rad/s] Frequency [rad/s]
Figure A.1: Measured and estimated relative permittivity spectrum for oil 1S.
Table A.1: The found parameters p∗ and the initial guesses p0 for oil 1S using the variable
projection method and the Levenberg-Marquardt method.
A.2 Oil 2S
2.3 2.3
2.25 2.25
2.2 2.2
2.15 2.15
ℜ [ε]
ℜ [ε]
2.1 2.1
2.05 2.05
2 2
0.02 0.02
0.01 0.01
ℑ [ε]
ℑ [ε]
0 0
−0.01 −0.01
−0.02 −0.02
−0.03 −0.03
6 7 8 6 7 8
10 10 10 10 10 10
Frequency [rad/s] Frequency [rad/s]
Figure A.2: Measured and estimated relative permittivity spectrum for oil 2S.
Table A.3: The found parameters p∗ and the initial guesses p0 for oil 2S using the variable
projection method and the Levenberg-Marquardt method.
A.3 Oil 3S
2.35 2.35
2.3 2.3
2.25 2.25
ℜ [ε]
ℜ [ε]
2.2 2.2
2.15 2.15
2.1 2.1
Measured Measured
0.05 0.05
Estimated Estimated
0.04 0.04
0.03 0.03
ℑ [ε]
ℑ [ε]
0.02 0.02
0.01 0.01
0 0
−0.01 −0.01
−0.02 −0.02
6 7 8 6 7 8
10 10 10 10 10 10
Frequency [rad/s] Frequency [rad/s]
Figure A.3: Measured and estimated relative permittivity spectrum for oil 3S.
Table A.5: The found parameters p∗ and the initial guesses p0 for oil 3S using the variable
projection method and the Levenberg-Marquardt method.
A.4 Oil 4S
2.3 2.3
2.25 2.25
2.2 2.2
2.15 2.15
ℜ [ε]
ℜ [ε]
2.1 2.1
2.05 2.05
2 2
Measured Measured
1.95 1.95
Estimated Estimated
6 7 8 6 7 8
10 10 10 10 10 10
Frequency [rad/s] Frequency [rad/s]
Measured Measured
0.04 0.04
Estimated Estimated
0.03 0.03
0.02 0.02
ℑ [ε]
ℑ [ε]
0.01 0.01
0 0
−0.01 −0.01
−0.02 −0.02
−0.03 −0.03
6 7 8 6 7 8
10 10 10 10 10 10
Frequency [rad/s] Frequency [rad/s]
Figure A.4: Measured and estimated relative permittivity spectrum for oil 4S.
Table A.7: The found parameters p∗ and the initial guesses p0 for oil 4S using the variable
projection method and the Levenberg-Marquardt method.
A.5 Oil 5B
2.45 2.45
2.4 2.4
2.35 2.35
2.3 2.3
ℜ [ε]
ℜ [ε]
2.25 2.25
2.2 2.2
2.15 2.15
Measured Measured
2.1 Estimated 2.1 Estimated
6 7 8 6 7 8
10 10 10 10 10 10
Frequency [rad/s] Frequency [rad/s]
0.06 0.06
Measured Measured
0.05 Estimated 0.05 Estimated
0.04 0.04
0.03 0.03
ℑ [ε]
ℑ [ε]
0.02 0.02
0.01 0.01
0 0
−0.01 −0.01
6 7 8 6 7 8
10 10 10 10 10 10
Frequency [rad/s] Frequency [rad/s]
Figure A.5: Measured and estimated relative permittivity spectrum for oil 5B.
Table A.9: The found parameters p∗ and the initial guesses p0 for oil 5B using the
variable projection method and the Levenberg-Marquardt method.
A.6 Oil 6B
2.55 2.55
2.5 2.5
2.45 2.45
2.4 2.4
ℜ [ε]
ℜ [ε]
2.35 2.35
2.3 2.3
2.25 2.25
0.04 0.04
0.03 0.03
ℑ [ε]
ℑ [ε]
0.02 0.02
0.01 0.01
0 0
−0.01 −0.01
6 7 8 6 7 8
10 10 10 10 10 10
Frequency [rad/s] Frequency [rad/s]
Figure A.6: Measured and estimated relative permittivity spectrum for oil 6B.
Table A.11: The found parameters p∗ and the initial guesses p0 for oil 6B using the
variable projection method and the Levenberg-Marquardt method.
A.7 Oil 7S
2.4 2.4
2.35 2.35
2.3 2.3
2.25 2.25
ℜ [ε]
ℜ [ε]
2.2 2.2
2.15 2.15
2.1 2.1
Measured Measured
2.05 2.05
Estimated Estimated
6 7 8 6 7 8
10 10 10 10 10 10
Frequency [rad/s] Frequency [rad/s]
Measured Measured
0.05 0.05
Estimated Estimated
0.04 0.04
0.03 0.03
ℑ [ε]
ℑ [ε]
0.02 0.02
0.01 0.01
0 0
−0.01 −0.01
−0.02 −0.02
6 7 8 6 7 8
10 10 10 10 10 10
Frequency [rad/s] Frequency [rad/s]
Figure A.7: Measured and estimated relative permittivity spectrum for oil 7S.
Table A.13: The found parameters p∗ and the initial guesses p0 for oil 7S using the
variable projection method and the Levenberg-Marquardt method.
2.2 2.2
2.15 2.15
2.1 2.1
2.05 2.05
ℜ [ε]
ℜ [ε]
2 2
1.95 1.95
1.9 1.9
Measured Measured
1.85 Estimated 1.85 Estimated
6 7 8 6 7 8
10 10 10 10 10 10
Frequency [rad/s] Frequency [rad/s]
0.04 0.04
Measured Measured
0.03 Estimated 0.03 Estimated
0.02 0.02
0.01 0.01
ℑ [ε]
ℑ [ε]
0 0
−0.01 −0.01
−0.02 −0.02
−0.03 −0.03
6 7 8 6 7 8
10 10 10 10 10 10
Frequency [rad/s] Frequency [rad/s]
Figure A.8: Measured and estimated relative permittivity spectrum for oil 10S
Table A.15: The found parameters p∗ and the initial guesses p0 for oil 10S using the
variable projection method and the Levenberg-Marquardt method.
2.3 2.3
2.25 2.25
2.2 2.2
2.15 2.15
ℜ [ε]
ℜ [ε]
2.1 2.1
2.05 2.05
2 2
Measured Measured
1.95 1.95
Estimated Estimated
6 7 8 6 7 8
10 10 10 10 10 10
Frequency [rad/s] Frequency [rad/s]
0.02 0.02
0.01 0.01
ℑ [ε]
ℑ [ε]
0 0
−0.01 −0.01
−0.02 −0.02
−0.03 −0.03
6 7 8 6 7 8
10 10 10 10 10 10
Frequency [rad/s] Frequency [rad/s]
Figure A.9: Measured and estimated relative permittivity spectrum for oil 11B.
Table A.17: The found parameters p∗ and the initial guesses p0 for oil 11B using the
variable projection method and the Levenberg-Marquardt method.
2.35 2.35
2.3 2.3
2.25 2.25
2.2 2.2
ℜ [ε]
ℜ [ε]
2.15 2.15
2.1 2.1
2.05 2.05
Measured Measured
2 Estimated 2 Estimated
6 7 8 6 7 8
10 10 10 10 10 10
Frequency [rad/s] Frequency [rad/s]
Measured Measured
0.05 Estimated 0.05 Estimated
0.04 0.04
0.03 0.03
ℑ [ε]
ℑ [ε]
0.02 0.02
0.01 0.01
0 0
−0.01 −0.01
−0.02 6 7 8
−0.02 6 7 8
10 10 10 10 10 10
Frequency [rad/s] Frequency [rad/s]
Figure A.10: Measured and estimated relative permittivity spectrum for oil 12S.
Table A.19: The found parameters p∗ and the initial guesses p0 for oil 12S using the
variable projection method and the Levenberg-Marquardt method.
2.6 2.6
2.55 2.55
2.5 2.5
ℜ [ε]
ℜ [ε]
2.45 2.45
2.4 2.4
2.35 2.35
0.04 0.04
0.03 0.03
ℑ [ε]
ℑ [ε]
0.02 0.02
0.01 0.01
0 0
Measured
−0.01 Estimated −0.01
6 7 8 6 7 8
10 10 10 10 10 10
Frequency [rad/s] Frequency [rad/s]
Figure A.11: Measured and estimated relative permittivity spectrum for oil 13B.
Table A.21: The found parameters p∗ and the initial guesses p0 for oil 13B using the
variable projection method and the Levenberg-Marquardt method.
2.4 2.4
2.35 2.35
2.3 2.3
2.25 2.25
ℜ [ε]
ℜ [ε]
2.2 2.2
2.15 2.15
2.1 2.1
Measured Measured
2.05 Estimated 2.05 Estimated
6 7 8 6 7 8
10 10 10 10 10 10
Frequency [rad/s] Frequency [rad/s]
0.06 0.06
Measured Measured
0.05 Estimated 0.05 Estimated
0.04 0.04
0.03 0.03
ℑ [ε]
ℑ [ε]
0.02 0.02
0.01 0.01
0 0
−0.01 −0.01
6 7 8 6 7 8
10 10 10 10 10 10
Frequency [rad/s] Frequency [rad/s]
Figure A.12: Measured and estimated relative permittivity spectrum for oil 15B.
Table A.23: The found parameters p∗ and the initial guesses p0 for oil 15B using the
variable projection method and the Levenberg-Marquardt method.
2.65 2.65
2.6 2.6
2.55 2.55
2.5 2.5
ℜ [ε]
ℜ [ε]
2.45 2.45
2.4 2.4
2.35 2.35
Measured Measured
2.3 Estimated 2.3 Estimated
6 7 8 6 7 8
10 10 10 10 10 10
Frequency [rad/s] Frequency [rad/s]
0.08 0.08
Measured
0.07 0.07 Estimated
0.06 0.06
0.05 0.05
ℑ [ε]
ℑ [ε]
0.04 0.04
0.03 0.03
0.02 0.02
Measured
0.01 0.01
Estimated
6 7 8 6 7 8
10 10 10 10 10 10
Frequency [rad/s] Frequency [rad/s]
Figure A.13: Measured and estimated relative permittivity spectrum for oil 16S.
Table A.25: The found parameters p∗ and the initial guesses p0 for oil 16S using the
variable projection method and the Levenberg-Marquardt method.
2.25 2.25
2.2 2.2
2.15 2.15
2.1 2.1
ℜ [ε]
ℜ [ε]
2.05 2.05
2 2
1.95 1.95
Measured Measured
1.9 Estimated 1.9 Estimated
6 7 8 6 7 8
10 10 10 10 10 10
Frequency [rad/s] Frequency [rad/s]
0.02 0.02
0.01 0.01
ℑ [ε]
ℑ [ε]
0 0
−0.01 −0.01
−0.02 −0.02
−0.03 −0.03
6 7 8 6 7 8
10 10 10 10 10 10
Frequency [rad/s] Frequency [rad/s]
Figure A.14: Measured and estimated relative permittivity spectrum for oil 17S.
Table A.27: The found parameters p∗ and the initial guesses p0 for oil 17S using the
variable projection method and the Levenberg-Marquardt method.
2.5 2.5
2.45 2.45
2.4 2.4
2.35 2.35
ℜ [ε]
ℜ [ε]
2.3 2.3
2.25 2.25
2.2 2.2
Measured Measured
2.15 Estimated 2.15 Estimated
6 7 8 6 7 8
10 10 10 10 10 10
Frequency [rad/s] Frequency [rad/s]
0.07 0.07
Measured Measured
0.06 Estimated 0.06 Estimated
0.05 0.05
0.04 0.04
ℑ [ε]
ℑ [ε]
0.03 0.03
0.02 0.02
0.01 0.01
0 0
6 7 8 6 7 8
10 10 10 10 10 10
Frequency [rad/s] Frequency [rad/s]
Figure A.15: Measured and estimated relative permittivity spectrum for oil 18B.
Table A.29: The found parameters p∗ and the initial guesses p0 for oil 18B using the
variable projection method and the Levenberg-Marquardt method.
[1] K. Cole and R. Cole, “Dispersion and absorption in dielectrics - i alternating current
characteristics,” J. Chem. Phys., vol. 9, pp. 341–352, 1941.
[5] Y. Luo and Y. Zhang, Theory and Application of Spectral Induced Polarization (Geo-
physical Monograph Series, N0.8). Society of Exploration, 1998.
[6] J. Milton, Field Geophysics. Geological Society of London Handbook Series. Wiley,
1996.
[8] Y. Yang, W. Ni, Q. Sun, H. Wen, and Z. Teng, “Improved cole parameter extraction
based on the least absolute deviation method,” Physiological Measurement, vol. 34,
no. 10, 2013.
[10] S. R. Jagger and P. A. Fell, “Forward and inverse cole-cole modeling in the analysis
of frequency domain electrical impedance data,” Exp. Geophys., vol. 19, pp. 463–470,
1988.
[11] K. Levenberg, “A method for the solution of certain non-linear problems in least
squares,” Quarterly of Applied Mathematics, vol. 2, pp. 164–168, 1944.
59
60
[17] J. Nocedal and S. Wrigth, Numerical Optimization, 2nd edition. Springer, 2006.
[19] P. Debye, Polar Molecules. The Chemical Catalog Company, Inc., 1929.
[21] P. Wolfe, “Convergence conditions for ascent methods,” SIAM Review, vol. 11, no. 2,
pp. 226–000, 1969.
[22] P. Bergström and I. Söderkvist, “Fitting nurbs using separable least squares tech-
niques,” IJMMNO, vol. 3, no. 4, pp. 319–334, 2012.