You are on page 1of 17

C

7
H A P T E R

Signal and Image


Processing for
Electromagnetic Testing

Lalita Udpa, Michigan State University, East Lansing,


Michigan
PART 1. Signal Enhancement

Signal and image processing techniques techniques such as wavelet shrinkage


are valuable for the accurate and denoising. In general, the noise contained
consistent interpretation of signals in in a signal can be attributed to several
nondestructive testing. Signal processing sources, including instrumentation, probe
performs important functions in data wobble and variations in liftoff and
analysis ranging from simple noise surface roughness. Signals can be
filtering for enhancing the ratio of signal enhanced using simple standard linear
to noise to automated signal classification low pass filters, band stop filters and band
for improving discontinuity detectability. pass filters.2 These filters are often
This chapter focuses on some of the more implemented in either hardware or
advanced signal processing techniques. software and available as special features
Classical texts can provide a fundamental in the instrument. However, these filters
understanding of the subject.1,2 A are effective only when the signal is
schematic diagram for the overall stationary. A signal is considered
approach used in nondestructive test stationary when its statistical properties
signal analysis is shown in Fig. 1. such as mean or variance do not vary
Techniques of signal processing can be with time. Nondestructive test signals that
broadly classified into procedures for contain time localized discontinuity
(1) enhancement, (2) restoration, indications are, as a rule, nonstationary.
(3) classification and (4) characterization. Such problems are addressed using
These techniques are described below. techniques such as wavelet shrinkage
Signal enhancement techniques are denoising,3 described next.
used to minimize high frequency noise
and artifacts in a signal. These techniques
generally do not require a precise
understanding of the factors that Wavelet Shrinkage
contribute to the distortion. Techniques Denoising Filter
for enhancing the ratio of signal to noise
can range from simple averaging and low Consider a noisy signal yi represented by
pass filtering1 to more sophisticated the discrete time sequence:

(1) yi = xi + zi

FIGURE 1. Overall approach for signal analysis where i = 0, 1, , n1; subscript i is the
in nondestructive testing. time index of the signal; n is the length of
the time sequence; xi is the desired signal;
and zi represents conventional white
Raw signal noise (indicating that the noise is
uncorrelated1,2) with standard deviation
. The discrete wavelet transform
Preprocessing
decomposes a signal y into a weighted
Enhancement sum of basis functions v,k:
Restoration
(2) y(n ) = c
v k
v ,k v ,k (n)
Feature extraction

where v and k are integer values. The basis


functions v,k are derived by using
Classification dilations and translation operations from
Clustering
Neural networks
a single function , referred to as the
Discontinuity class mother wavelet:

Characterization and
v v
discontinuity profiling Discontinuity sizing (3) v,k (n) = 2 2 2 2 (n k )
Model based and profiling
System based

190 Electromagnetic Testing


where v and k are the dilation and shown in Fig. 2b. Although the resulting
translation parameters respectively. (Here, signal is relatively noise free, it contains
the terms dilation and translation should low frequency trends, which are
not be confused with the morphological undesirable.
operations called erosion and dilation.) In many inspection processes, the
Dilation is a scaling operation that statistical properties of noise can vary
compresses the time axis (that is, the X spatially, making conventional invariant
axis and not the Y axis) of a signal. position filters not very useful. In such
Translation involves shifting a signal in situations, adaptive filtering procedures
time. As in the case of fourier series are needed for noise removal.
coefficients,1,2 the wavelet transform
coefficients cv,k are determined by
projecting the signal onto the wavelet
basis set v,k. The wavelet transform W of Adaptive Filtering
Eq. 1 can be expressed as: Adaptive filtering approaches make use of
statistical correlation properties of noise
W ( yi ) W ( xi ) + W (zi )
and target signals. An adaptive noise
(4) =
cancellation scheme is shown in Fig. 3.4,5
= W ( xi ) + wi The reference signal di and the primary
input signal ui, obtained from adjacent
positions of the transducer, are applied to
for orthonormal basis functions (such as the filter H(z) and the filter output is
fourier bases), where wi represents W(zi). represented by yi. Assuming that the noise
Solving for xi yields: is uncorrelated with the input signal, an
adaptive filter can be designed to cancel
(5) xi = [
W 1 W ( yi ) wi ] the noise by minimizing the square error.
The mean square error is given by the
Because wi is in general unknown, expectation E of the squared error:
denoising can be accomplished by
removing the noise contribution from
each wavelet coefficient by applying a
(6) ( )
E i2 = E ( si yi + ni )
2

data dependent soft threshold.3


Wavelet shrinkage has found increasing If it is assumed that the reference signal
use in nondestructive test applications. di contains both signal and noise (that is,
Programs for fast implementation of the di = si + ni where si and ni are the
discrete wavelet transform are available discontinuity signal and grain noise
commercially. The result of implementing components respectively), then:
the wavelet shrinkage denoising filter on a
typical eddy current signal in Fig. 2a is
(7) ( )
E i2 = E ( si yi ) + E (ni )
2 2

+ 2 E (ni ) ( si yi )
FIGURE 2. Eddy current signals: (a) raw signal; (b) wavelet
denoised signal. If ni is uncorrelated with si and yi the last
(a) term reduces to zero:

E (ni ) ( si yi )
60
(8) = 0
Amplitude (mV)

50
40
and:
30
20
10 FIGURE 3. Overall schematic diagram of adaptive noise
0 20 40 60 80 100 120 cancellation.
Scan position (arbitrary unit)
Reference
(b) signal di
20
Amplitude (mV)

15
10 +
5 Input Adaptive filter yi
0 H(z) Output yi
signal ui
5
10
15 Error signal i
0 20 40 60 80 100 120

Scan position (arbitrary unit)

Signal and Image Processing for Electromagnetic Testing 191


(9) E 2i[ ] = E ( si yi ) + pn

2
Detrending
Noise and trends are common forms of
where pn is the noise power. distortion that are often present in eddy
When the filter is optimized, the error current and magnetic flux leakage signals.
is a minimum pn and the filter output Trends are low frequency changes in the
yi = si is completely noise free. signal levels caused by several factors
Figure 4a shows a magnetic flux including instrument drift and gradual
leakage signal obtained during tests of gas variations in probe orientation. In the
transmission pipelines. The measurements case of eddy current nondestructive
are corrupted by a periodic noise caused testing, low frequency trends are
by helical variations introduced by the introduced in the signal because of
manufacturing process. The result of gradual variations in probe liftoff. The raw
applying adaptive filtering (Fig. 3) is eddy current signal in Fig. 2a shows
shown in Fig. 4b.5 typical distortion introduced by slowly
varying trends. A commonly used
technique for eliminating such artifacts is
based on zero phase high pass filters,
Signal Restoration which can be implemented by using the
Signal restoration procedures are used discrete cosine transform.
when the distortion processes that
introduce specific artifacts in the signal Discrete Cosine Transform
are known and can be expressed in the
form of a mathematical function. Two The discrete cosine transform is a special
classes of signal restoration procedures are case of the discrete fourier transform1
discussed below: (1) low frequency trends where the basis functions consist of
and (2) the effect of the transducer cosines instead of complex exponentials.
footprint. These distortions can be The discrete cosine transform of an
eliminated by using restoration N-dimensional discrete time signal x is
procedures such as detrending and given by Eq. 10:
deconvolution, which are described next.

FIGURE 4. Results obtained from application of adaptive noise cancellation algorithm: (a) raw
magnetic flux leakage data; (b) output after noise cancellation.

(a)

20 (0.8)
Specimen width,

40 (1.6)
mm (in.)

60 (2.4)
80 (3.0)
100 (3.6)

2 4 6 8 10 12

Scan position (arbitrary unit)

(b)

20 (0.8)
Specimen width,

40 (1.6)
mm (in.)

60 (2.4)
80 (3.0)
100 (3.6)

2 4 6 8 10 12

Scan position (arbitrary unit)

192 Electromagnetic Testing


N 1 (13) y (t ) = x(t ) h(t ) + n(t )
(10) B(k ) = c(k ) x (i) cos 2Nk (2i + 1)
i =0
where h(t) represents the impulse response
of the measurement system or the point
where B(k) denotes the N transformed spread function, x(t) represents the true
values and where the coefficients for c(k) signal and the symbol is the
are given by: convolution operator. The fourier
transform of Eq. 13 yields:
c ( 0) =
1
(11)
N (14) Y (f ) = X (f ) H (f ) + N (f )

and: The estimation of the true function


X(f ) from Y(f ) is performed using the
wiener filter H(f ), characterized in the
c (k ) =
2
(12) frequency domain by:6
N

for 1 k N 1. H (f )
To get rid of the low frequency trends, (15) H (f ) =
H (f )
2
the low frequency coefficients in the + Q
transformed signal B(k) are set to zero and
the signal is reconstructed. This technique
results in removing the low frequency where H(f ) is the complex conjugate of
trends and the mean without affecting the H(f ) and Q is related to the ratio of signal
phase information, crucial in eddy current to noise. Wiener filters6 use a constrained
signals. Figure 5 shows the results of least squares minimization procedure to
discrete cosine transform based estimate x(t) from the measurement y(t).
detrending of the eddy current signal in Although this technique is well
Fig. 2a. established, it requires knowledge of H(f ).
In cases where the distortion kernel H(f )
is not available, blind deconvolution
algorithms can be used as described
Deconvolution below.
A second source of distortion is the
blurring of a signal because of the point Blind Deconvolution
spread function or impulse response of Blind deconvolution techniques are
the transducer. Deconvolution techniques particularly attractive because they do not
can be used to eliminate transducer require specification of the distortion
responses from signals and thereby kernel. These algorithms iteratively
estimate the true response. One of the estimate the kernel (in this case the point
most popular restoration techniques uses spread function of the probe) from the
the wiener filter. available data. Another advantage
associated with blind deconvolution
Wiener Filtering algorithms is the ease with which
constraints can be added. This property
The wiener filter models the measured
can be used to constrain the size of the
signal y(t) as the output of a linear time
kernel based on the size of the probe
invariant system corrupted by noise n(t):6
used. The blind deconvolution technique
based on the richardson-lucy algorithm7
uses maximum likelihood principles and
obtains high quality reconstructed images
FIGURE 5. Eddy current signal after detrending of signal in even in the presence of noise. Consider
Fig. 2a. the experimental (convolved) eddy
20
current image data c(x,y) obtained using a
Amplitude (mV)

raster scan of a test object. Let f(x,y)


10
represent the true image that would be
0
obtained with a point sensor.
10 The richardson-lucy algorithm is based
20 on Bayes theorem:
30
0 20 40 60 80 100 120

(16) ( )
P xy =
( )
P y x P ( x)

P (y x) P (x) dx
Scan position (arbitrary unit)

Signal and Image Processing for Electromagnetic Testing 193


where P(y|x) is the conditional probability
c(m, n)
f ik+1(m, n) =
of an event y, and the probability P(x) of
(20)
f i (m, n) g (m, n)
an event X. In the context of k k
deconvolution, P(x) and P(y) are identified
with the unknown f(x,y) to be estimated
and the convolved (or measured) image
}
g k ( m, n) f ik (m, n)
c(x,y), respectively. Also, the conditional
probability P(y|x) is identified as the These two steps are repeated until
kernel function or the point spread convergence is achieved.
function centered at (x,y), that is, g(x,y). Some typical results of applying this
Equation 16 can be used to derive the algorithm to data from an eddy current
iterative form of the deconvolution pancake coil probe are presented in Fig. 6.
algorithm7 in the discrete domain as: Figure 7 shows the results of blind
deconvolution on experimental eddy
c (m, n) current measurements, illustrating how
(17) f i +1(m, n) = the process of deconvolution can help in
f i (m, n) g (m, n) resolving two closely spaced
}
g ( m, n) f i (m, n)
discontinuities.

where i is the iteration number. All FIGURE 6. Images from pancake coil probes: (a) true image;
quantities in Eq. 17 are two-dimensional (b) gaussian point spread function kernel; (c) measured,
and depend on two spatial variables m convolved image; (d) result of blind deconvolution.
and n. Given the point spread function
g(m,n) and an initial guess of the original (a) (b) (c) (d)
image f(m,n), the reconstructed image can
be obtained by iteratively applying Eq. 17
until convergence.
The inverse iterative equation, derived
by reversing the role of the reconstructed
image and the point spread function in
Eq. 17, is given by:


c (m, n)
(18) g i +1(m, n) =
g i (m, n) f (m,n)
k 1 FIGURE 7. Eddy current test with two closely
spaced discontinuities: (a) raw image;
}
f ( m, n) g i (m, n) (b) result of blind deconvolution algorithm.

(a) (b)
The inverse iterative equation is also
referred to as a richardson-lucy operation.
The blind deconvolution algorithm
consists of a two-step procedure. At the
kth iteration, the point spread function
g k(y,x) is calculated from Eq. 19 by
performing a specific number of
richardson-lucy operations, given the
knowledge of the reconstructed image
f k1(m,n) obtained from Eq. 20 after the
(k1)th iteration:


c (m, n)
(19) g ik+1(m, n) =
g i (m, n) f (m,n)
k k 1

}
f k 1( m, n) g ik (m, n)

Here, k denotes the iteration number and


i denotes the number of richardson-lucy
operations during each iteration. The new
estimate of the deconvolved image f k(m,n)
is obtained by performing the same
number of richardson-lucy operations
(Eq. 20), given the point spread function
gk(m,n) obtained from Eq. 19 above:

194 Electromagnetic Testing


PART 2. Signal Classification

Signal classification techniques often rely cosine transform coefficients8 and scale
on pattern recognition for interpreting based features such as discrete wavelet
nondestructive test data. Pattern transform coefficients,9 principal
recognition techniques help to classify components10 and linear predictive
signals into one of a known set of classes. coding coefficients.11 These feature
Such techniques may be used, for extraction schemes are described below.
example, to discriminate between
multiple types of discontinuities or
between discontinuities and benign
Discrete Fourier Transform
sources. In the case of steam generator One of the earliest and simplest
tube tests, for example, such techniques techniques used for feature extraction is
could be used to distinguish eddy current the discrete fourier transform. The discrete
signals from those caused by cracks, tube fourier transform of a signal x(n) can be
supports and antivibration bars. The expressed as the weighted sum of complex
parameters of the classifier are generally exponential basis functions. For a series
determined by using a data bank of x(n) with N samples, the discrete fourier
signals from expected discontinuity types. transform is expressed as:
The collection of signals, referred to as the
training database, is used for training the
jn 2
X (k ) x(n) e
1
classification algorithm. Most (21) = N
classification techniques use a two-step N
n
procedure.
1. In feature extraction, characteristic where k = 0, 1, , N1.
features in the signal that carry For smooth signals, the magnitude of
discriminatory information are the coefficients can be shown to decay at
identified and extracted. These the rate of n 2 with the result that the
features serve as a compact signature energy can be compacted in very few
of the signal. discrete fourier transform coefficients.
2. The feature vector is classified by using Magnitudes of the discrete fourier
a standard pattern classification transform coefficients are the simplest
technique such as a clustering and most commonly used feature vector
algorithm or a neural network. for representing signals for classification.

Discrete Cosine Transform


Feature Extraction The discrete cosine transform is a special
case of the discrete fourier transform
Feature extraction serves two major where the basis functions consist of
functions, namely data compression and cosines instead of complex exponentials.
invariance with respect to parameters Repeating Eq. 10, the discrete cosine
such as frequency and gain. Features are transform of an N-dimensional discrete
data attributes that capture similarities in time signal x is given by:
signals from the same class as well as
dissimilarities in signals from different N 1
k
classes. In addition to containing
discriminatory information, the feature
(22) B (k ) = c (k ) x (i) cos 2 N (2i + 1)
i =0
vector is typically of lower dimension
than the signal, resulting in data
compression. Features can be physical or where Bk denotes the N transformed
structural (peak value, rise time, values and where the coefficients for c(k)
peak-to-peak separation and others) or are given by:
transform based (fast fourier transform,
c ( 0)
discrete cosine transform and others). 1
(23) =
Transform based features are more easily N
implemented by using numerical
algorithms. Examples of commonly used
transform based features are discrete and:
fourier transform coefficients,1 discrete

Signal and Image Processing for Electromagnetic Testing 195


k

[ ]

c (k )
2
(24) = (26) v ,k (n) = 2 2 2 k (n k )
N

for 1 k < N 1. The discrete wavelet transform


This technique results in a feature coefficients Cv,k are determined by
vector composed of a smaller number of projecting the signal x(n) onto the wavelet
coefficients Bk that can represent the basis set v,k (n). It is usually implemented
signal. as a series of subband filters. The most
common version is the two-band discrete
wavelet transform, which uses two finite
Discrete Wavelet Transform impulse response filters a low pass filter
The discrete wavelet transform9 of a signal and a high pass filter.
x(n) is a joint time scale transform that The computation of the discrete
provides both time and frequency wavelet transform coefficients for a data
localization of a signal. The discrete vector x of length n (where n indicates the
wavelet transform can be expressed as the number of points in the signal) is
weighted sum of basis functions: indicated in Fig. 8, which presents a fast
implementation of the discrete wavelet
(25) x(n) = C
v k
v ,k v ,k (n)
transform using a filter bank approach.
The output of each filter is downsampled
by a factor of 2 by discarding every other
sample. The output of the high pass filter
where realizations of the wavelet basis represents the discrete wavelet transform
function v,k(n) are derived from a single coefficients at the first resolution level.
function (n), referred to as the mother The output of the low pass filter is then
wavelet, by dilations v and translations k applied to the same set of filters and
according to: sampled again. The output of the high
pass filter is retained as the discrete
wavelet transform coefficients at the

FIGURE 8. Filter bank approach for discrete wavelet transform computation.9

x[n]

g[n] h[n]

2 2
1
DWTlow = h[k] x[2n k]
k
1
DWThigh = g [k] x[2n k]
k
g[n] h[n]

Level 1 DWT
Coefficients 2 2

Level 2 DWT
Coefficients g[n] h[n]

2 2

Level 3 DWT
Coefficients

Legend
DWT = discrete wavelet transform
g = high pass function
h = low pass function
k = iteration number
n = number of points in signal
x = data vector

196 Electromagnetic Testing


second resolution level. This process is Linear Predictive Coding
repeated until the number of samples is Coefficients
reduced to 1. The number of possible
resolution levels is given by : Linear predictive modeling11 is commonly
used in the processing of speech signals.
Linear predictive coding coefficients are
(27) = log 2 n known to accurately represent speech
signals with a small set of parameters. The
Because the discontinuity related approach can be used also for extracting
information is typically present in the features from test signals.
discontinuity scale subspace, an In linear predictive coding analysis, it
appropriate set of coefficients in the is assumed that the present value of the
discontinuity subspace can be used as sample s(n) can be represented as a
features. weighted sum of the past samples. The
linear predictive coding coefficients are
estimated by minimizing the mean
Principal Component Analysis squared error between the predicted value
Principal component analysis is a and true value. The error (n) is given by:
statistical technique that linearly
transforms a time series sequence into a p
substantially smaller set of uncorrelated
variables that contains most of the
(30) (n) = s(n) s (n j)
j =1
j

information in the original data set.10 The


overall goal of principal component where j represents the estimates of the
analysis is to reduce the dimensionality of linear predictive coding coefficients.
the original data set. Principal component Setting the partial derivatives of the mean
analysis allows the reconstruction of the squared error with respect to j to zero for
original pattern from linear projections j = 1, 2, , p gives:
required to have sequentially maximal
variances. The basis vectors of the
representation are constrained to be p

mutually orthonormal. If X is an n n
data matrix of measurement vectors with
(31) E s(n)


j s(n j ) s(n i ) = 0


mean Mx and covariance matrix x (where j =1
subscript x represents a datum) an
orthogonal set of eigenvectors may be for i = 1, 2, , p. Equation 31 can be
found that diagonalizes the covariance rearranged:
matrix. By arranging the eigenvectors in a
matrix in accordance with decreasing p
eigenvalues (largest first), an ordered
orthogonal basis may be created that has
(32)
j =1
j n (i, j ) = n (i, 0)

the greatest degree of variability of the


data along the first eigenvector. Retaining for i = 1, 2, , p, where n is the
only p largest eigenvalues provides a autocorrelation function:
feature extraction operator , a p p
matrix of p eigenvectors. Using this
transformation matrix, a data set X may (33) n (i, j ) = { }
E s(n i ) s(n j )
be transformed to matrix Y:
The linear predictive coding coefficients
(28) Y = (X MX ) in Eq. 33 can be solved recursively by
using Durbins algorithm.11
making Y an orthonormal projection of X Nondestructive test signals can be
onto the columns of the transformation represented by a small set of linear
matrix. The inverse transformation may predictive coding coefficients, thereby
be used to reconstruct the original data achieving data reduction and compaction.
set X by: The coefficients represent the signal and
serve as a reduced dimensional feature
X = T Y + M X vector.
(29)

where T represents the transpose of


matrix . The matrix Y represents X in Feature Evaluation
the domain spanned by the vectors 1, , Once the features are computed, a feature
p. These columns of Y are referred to as
evaluation and selection step may be used
the principal components of the data set X to eliminate redundancy in the
and are of a lower dimension than the representation and to evaluate the
original data vectors. features on the basis of the discriminatory
information. More importantly, the

Signal and Image Processing for Electromagnetic Testing 197


selection step offers an opportunity to sample vector x in class Ci around their
choose features invariant either to respective mean mi, where P(Ci) is the
changes in test conditions or to some prior probability of class Ci and where Sb
selected aspect of the test object is the between-class scatter matrix,
properties. Because nondestructive test representing the scatter of the conditional
signals are acquired under varying test mean vectors mi around the overall mean
conditions, the results are sensitive to vector m.
instrument drift and to variations in Various measures are available for
probe characteristics, scanning speeds, quantifying the discriminatory power, the
gain settings, operating frequencies and commonly used one being:
test object conductivity and permeability.
A major challenge lies in the development W T Sw W
of signal processing schemes to (37) J (W ) =
compensate the signal for variations in W T Sb W
experimental test parameters. Such
schemes are crucial for rendering the
overall signal classification performance Here W is the optimal discrimination
insensitive to the environment in which projection vector, which can be obtained
the signal was acquired. by solving the generalized eigenvalue
A number of procedures capable of problem:
selecting features on the basis of
discriminatory information in them have (38) Sb W = Sw W
been proposed. The process begins with
the selection of candidate features.12,13
Each candidate is then evaluated and where is an eigenvalue.
either accepted or rejected on the basis of An example of a feature extraction
the amount of discriminatory information procedure that offers dimensionality
contained in it. In the second step, the reduction as well as invariance properties
goal is to identify features that contain involves fourier descriptors.15 The
the greatest amount of discriminatory technique has been used for representing
information. One popular technique for eddy current impedance plane trajectories.
feature reduction is called fisher linear The model not only represents the signal
discrimination.14 The technique uses a by a few coefficients, which are invariant
statistical weight function for each feature under rotation, translation and scaling of
to determine the optimum feature set the eddy current impedance plane
with the greatest amount of trajectory, but also allows the resynthesis
discriminatory information to be selected of the original signal from the stored
for signal classification. Fisher linear coefficients.
discrimination quantifies the
discriminatory content of the different
features.
A typical fisher linear discriminant Classification Algorithms
implementation is carried out by using The features computed in the previous
scatter matrix analysis. The within-class step are applied as input to a classification
and between-class scatter matrices are algorithm for data interpretation. Two of
computed as follows: the most widely used pattern
Let i be the scatter matrix of the classification techniques are (1) clustering
sample vector x in class Ci around their algorithms and (2) neural networks. These
respective mean mi: techniques are described next.

i = E ( x mi ) ( x mi ) | C = Ci K Means Clustering
T
(34)
Clustering algorithms treat a feature
vector as a point in the N-dimensional
Then Sw can be defined: feature space.16 Feature vectors from a
similar class of signals then form a cluster
M in the feature space. The most popular of
P (C )
1 the clustering algorithms is the K means
(35) Sw = i i
M clustering algorithm, which uses an
i =1
iterative procedure that classifies each
and: input signal into one of K classes.
M

P(C )(m m)(m m)


1 T
(36) Sb = i i i K Means Algorithm
M
i =1 The objective of the K means clustering
algorithm is to partition the feature space
where Sw is the within-class scatter matrix into K mutually exclusive regions. The
showing the average scatter i of the partitioning is performed in a way that

198 Electromagnetic Testing


minimizes a performance index or cost
x
1
function F equal to the sum of the square (42) zij +1 =
of distance between the cluster center and N cj
xw ij
all points within the cluster.
Let the number of patterns be Nc.
4. If zij+1 = zij for all i = 1, 2, , K, the
1. Assign any K (first K, randomly algorithm has converged and the
selected K or user assigned K) patterns process can be terminated. Otherwise
as the K cluster centers zi, where i = 1, go to step 2.
2, , K.
The K means algorithm converges if the
2. Assign each of the remaining Nc K
classes are linearly separable and the
patterns at the jth iteration to one of
performance generally is better if the
the K clusters whose center is closest
initial cluster centers are chosen from the
(using the euclidian norm):
K classes.
j
(39) x wm
Neural Networks
where wmj is the mth cluster in the jth Neural networks provide an alternate
iteration and: approach for classification. Interest in this
approach arose from a desire to mimic
j biological nervous systems with respect to
(40) x zm < x znj
architecture as well as information
processing strategies.17 The network
for 1 m, n K. consists of simple processing elements
3. Update the cluster centers zij+1, i = 1, 2, interconnected by weights. The network is
K, in a manner that minimizes the first trained using an appropriate learning
performance index: algorithm for the estimation of
interconnection weights. Once the
2
(41) Fij = x zij +1
network is trained, unknown test signals
can be classified. The class of neural
xN cj networks used most often for
classification tasks is the multilayer
where Fi j is the cost function perceptron network.
corresponding to the ith cluster in the The multilayer perceptron network
jth iteration and Ncj is the number of (Fig. 9) generally consists of an input layer
patterns in the cth cluster in the jth of nodes, one or more hidden layers of
iteration. It can be shown that the nodes and an output layer of nodes.
centers zij+1, i = 1, 2, , K), which Nodes within the same layer are not
minimize the above performance connected. However, each layer of nodes
index, are the sample mean of all is fully interconnected to the nodes in the
points within the cluster: next layer. All units within a layer process
data in parallel but the outputs of
different layers are calculated sequentially

FIGURE 9. Architecture of multiplayer perceptron neural network.

Synaptic weights
Output
Input

Neurons

Signal and Image Processing for Electromagnetic Testing 199


starting from the input layer and moving desired output by adapting the
toward the output layer. Each node interconnection weights iteratively. The
generates an output that is a nonlinear algorithm cycles through the training data
function of the weighted sum of all its repeatedly until the error drops below a
input signals. This nonlinear function is specified threshold value. Neural networks
primarily used to limit the output of a have been used with success for the
node between the values of 0 and 1. classification of eddy current and
The network is trained using the ultrasonic signals.19
backward error propagation algorithm18
where training patterns are sequentially
applied to the network. The overall
algorithm is summarized in Fig. 10. The
algorithm uses a gradient search
technique for minimizing the squared
error between the actual output and the

FIGURE 10. Flow chart of backpropagation training algorithm


for multilayer perceptron networks.

Initialize weight w and activation


function

f ( x) =
1
1 + e x

Present input x and


desired output d

Calculate network output y

Compute error

1 2
= dy
2

Yes
< ?

No No

Update weight

output
j = ( )( )
y 1 y j dj y j End of training
data?

hidden
j = xj (1 xj ) k w j,k
k Nodes in layers Yes
above node j

wi,j (t + 1) = wi,j (t ) + j xi End

[
+ wij (t ) wij (t 1) ]
Legend
d = output at node j
t = time
w = weighting factor
x = input signal
y = network output at node j
= momentum parameter
= variable defined by equation
= learning parameter
= preset threshold value for error

200 Electromagnetic Testing


PART 3. Signal Characterization

Signal characterization involves a more networks for solving the discontinuity


complete solution to the inverse problem. characterization problem. An approach
In material science, the inverse problem using a radial basis function neural
involves reasoning from effects (that is, network for the inversion of magnetic
indications) in order to draw inferences flux leakage signals is described next.20
about test objects. Characterization
techniques use information contained in
the signal to estimate the size, shape and
location of discontinuities. In other Radial Basis Function
words, characterization procedures Networks
involve the full two-dimensional or
three-dimensional reconstruction of Radial basis function networks can be
discontinuity profiles in terms of the viewed as tools for multivariate
spatial distribution of the material interpolation.20 Such networks can be
properties of the test object. In general, used for estimating a hypersurface that
the objective of the signal or provides what can be called the best fit to
discontinuity characterization procedure the training data. The architecture of the
can be described as the identification of a radial basis function network is in many
mapping f such that: respects similar to that of a multilayer
perceptron, defined above. A nonlinear
transformation of the signal is performed
(43) D = f (S) between the input and hidden nodes
followed by a linear transformation
where S represents the measurement between the hidden and output nodes.
vector from a scan in two dimensions M Mathematically, the radial basis function
and Q: network computes a multidimensional
function:

(44) S = { sij }M Q N
(46) f ( x) = w ( x c )
i =1
i i i

and D represents the discontinuity profile:


where i is a set of basis functions, ci are
(45) D = { dij }R P the basis centers and wi are the weights.
Substituting the values in the training
data {xi, f(xi), i = 1, , N} in Eq. 46 makes
The value of dij represents the depth of it possible to derive the matrix equation:
the discontinuity at a location (i,j).
Several approaches have been
developed for solving the inverse problem (47) f = w
in nondestructive testing. These solutions
can be categorized as either The training of the radial basis function
phenomenological or network consists of estimating the
nonphenomenological. Phenomenological expansion coefficients, which can be done
techniques are based on the underlying by inverting Eq. 47:
physical process of the nondestructive test
technique. Examples of the
phenomenological approach for inversion (48) w = 1 f
are based on analytical solutions of the
underlying governing equation, which is
in general a difficult problem. Once the weights are estimated by
Nonphenomenological approaches do not using the training data, the radial basis
depend on the physics of the inspection function network can be used to invert a
technique. These approaches model the test signal x according to Eq. 46.
nondestructive test system as a black box Reconstruction results can be further
or as a linear system and use signal improved by using a variation of the
processing techniques to invert the radial basis function network, a
measured signal. Typical signal processing multiresolution approach that uses neural
approaches for inversion use neural networks with wavelet basis functions.21

Signal and Image Processing for Electromagnetic Testing 201


These networks, called wave nets, use a
FIGURE 11. Architecture of wavelet basis hierarchical architecture associated with
function network. multiple levels of resolution or scale for
both global and local interpolation as
shown in Fig. 11. The network is trained
hierarchically, first to learn the mapping
L between inputs and outputs at the
coarsest resolution and later to augment
the mapping with details at higher
resolutions.
x L f(x) Mathematically, the approximation of
a scalar function f(t) can be expressed as:

NL
(49) f ( x) = s
j =1
L L
j j ( x)
1 Nk
L
+ d
k =1 j =1
k k
j j ( x)
Legend
L = scale index (superscript)
x = input to network where d jk denotes the corresponding
f(x) = function output
= scaling function
expansion coefficients; f(x), the mapping
= wavelet basis function function to be estimated; sjL, the scaling
coefficients; jk (x), the wavelet basis
functions generated via translations and

FIGURE 12. Neural network characterization of magnetic flux leakage signal from 75 mm (3 in.) long and 75 mm (3 in.) wide
discontinuity: (a) magnetic flux leakage signal; (b) discontinuity profile; (c) prediction using radial basis function network;
(d) prediction using wavelet basis function network.21

(a) (c)
Magnetic flux density, 1 (kG)

1.0 (10)
0)
0.5 (5)
Depth, mm (in.)

1.3 (0.05)
0
2.5 (0.10)
0.5 (5)
3.8 (0.15)
1.0 (10)
50 5.0 (0.20)
40 300
30 150 (6)
200 150 (6)
20 100 (4)
10 100
Circumferential 100 (4)
0 0 50 (2) 50 (2)
scan positions Axial scan positions
(arbitrary unit) (arbitrary unit) Width, mm (in.) 0 0
Length, mm (in.)

(b) (d)

0.1
0)
Normalized depth
Depth, mm (in.)

1.3 (0.05) 0
(ratio)

2.5 (0.10)
0.1
3.8 (0.15)

5.0 (0.20)
0.2
150 (6) 150 (6)
150 (6) 150 (6)
100 (4) 100 (4)
100 (4)
100 (4)
50 (2) 50 (2) 50 (2)
Width, mm (in.) 50 (2)
0 0 Width, mm (in.) 0 0
Length, mm (in.) Length, mm (in.)

202 1Electromagnetic Testing


dilations of a mother wavelet (x); and
jL, the scaling basis functions at
resolution L.
The first term represents the
approximation of the function at the Lth
resolution and the second term represents
additional information pertaining to the
details at the corresponding resolution.
The accuracy of the discontinuity
reconstruction can then be controlled by
selecting the number of resolution levels
in the network architecture. The training
algorithm for wave nets is similar to that
used for training a radial basis function
network.
Initial results obtained using both
radial basis function networks and
wavelet basis function networks using a
two-dimensional magnetic flux leakage
signal as input are shown in Fig. 12. The
magnetic flux leakage signal is obtained
from a rectangular notch machined on
the pipe wall. The results obtained using
the trained radial basis function network
and the wavelet basis function network
are compared with the true profile. These
results show that such
nonphenomenological techniques for
inversion can be trained to perform well
for measurements as long as the
measurements are similar to those used
for training the network.

Summary
Advances in digital processing have made
sophisticated signal and image processing
techniques available for practical
applications in nondestructive testing.
When integrated in software programs for
discontinuity classification, signal
processing algorithms make possible the
automation of diagnostic procedures and
quality assurance protocols.

Signal and Image Processing for Electromagnetic Testing 203


References

1. Oppenheim, A.O. and R.W. Schafer. 11. Makhoul, J. Linear Prediction:


Discrete Time Signal Processing. Upper A Tutorial Review. Proceedings of the
Saddle River, NJ: Prentice Hall (1989). IEEE. Vol. 62. New York, NY: Institute
2. Mitra, S.K. Digital Signal Processing: of Electrical and Electronics Engineers
A Computer-Based Approach. Boston, (April 1975): p 561-580.
MA: McGraw-Hill/Irwin (2001). 12. Doctor, P.G., T.P. Harrington,
3. Donoho, D.L. Nonlinear Wavelet T.J. Davis, C.J. Morris and D.W. Fraley.
Methods for Recovery of Signal Pattern Recognition Methods for
Densities and Spectra from Indirect Classifying and Sizing Flaws Using
and Noisy Data. Proceedings of Eddy-Current Data. Eddy Current
Symposia in Applied Mathematics. Characterization of Materials and
Vol. 47. Providence, RI: American Structures. Special Technical
Mathematical Society (1993): Publication 722. West Conshohocken,
p 173-205. PA: ASTM International (1980):
4. Kim, J., L. Udpa and S.S. Udpa. p 464-483.
Multistage Adaptive Noise 13. Burch, S.F., A.R. Lomas and
Cancellation for Ultrasonic A.T. Ramsey. Practical Automated
Nondestructive Evaluation. Review of Ultrasonic Signal Characterization of
Progress in Quantitative Nondestructive Welding Defects. British Journal of
Evaluation [Snowbird, Utah, Non-Destructive Testing. Vol. 32, No. 7.
July 1998]. Vol. 18A. New York, NY: Northampton, United Kingdom:
Plenum Press (1999): p 781-787. British Institute of Non-Destructive
5. Afzal, M., S.S. Udpa, L. Udpa and Testing (July 1990): p 347-350.
W. Lord. Rejection of Seamless Pipe 14. Duda, R.O. and P. Hart. Pattern
Noise in Magnetic Flux Leakage Data Classification and Scene Analysis. New
Obtained from Gas Pipeline York, NY: John Wiley and Sons (1973).
Inspection. Review of Progress in 15. Udpa, S.S. and W. Lord. A Fourier
Quantitative Nondestructive Evaluation Descriptor Classification Scheme for
[Montreal, Canada, July 1999]. Differential Probe Signals. Materials
Vol. 19B. New York, NY: Plenum Press Evaluation. Vol. 42, No. 9. Columbus,
(2000): p 1589-1596. OH: American Society for
6. Neal, S. and D.O. Thompson. An Nondestructive Testing (August 1984):
Examination of the Application of p 1136-1141.
Wiener Filtering to Ultrasonic 16. Tou, J.T. and R.C. Gonzalez. Pattern
Scattering Amplitude Estimation. Recognition Principles. Reading, MA:
Review of Progress in Quantitative Addison-Wesley (1974).
Nondestructive Evaluation 17. Lippmann, R.P. An Introduction to
[Williamsburg, VA, June 1985]. Computing with Neural Nets. IEEE
Vol. 5A. New York, NY: Plenum Press ASSP Magazine. Vol. 4. New York, NY:
(1986): p 737-746. Institute of Electrical and Electronics
7. Richardson, W.H. Bayesian-Based Engineers (April 1987): p 4-22.
Iterative Method of Image 18. Rumelhart, D.E., G.E. Hinton and
Restoration. Journal of the Optical R.J. Williams. Learning Internal
Society of America. Vol. 62, No. 1. Representations by Error Propagation.
Washington, DC: Optical Society of Parallel Distributed Processing:
America (January 1972): p 55-59. Exploration in the Microstructure of
8. Gonzalez, R.C. and R.E. Woods. Digital Cognition: Vol. 1, Foundations.
Image Processing, second edition. Upper Cambridge, MA: MIT Press (1986):
Saddle River, NJ: Prentice Hall (2002). p 318-362.
9. Strang, G. and T. Nguyen. Wavelets and 19. Udpa, L. and S.S. Udpa. Neural
Filter Banks. Wellesley, MA: Networks for Classification of NDE
Wellesley-Cambridge Press (1996). Signals. IEE Proceedings F:
10. Haykin, S.S. Neural Networks: Communications, Radar, and Signal
A Comprehensive Foundation, second Processing. Vol. 138. Stevenage,
edition. Upper Saddle River, NJ: Hertfordshire: Institution of Electrical
Prentice Hall (1999). Engineers (1981): p 41-45.

204 Electromagnetic Testing


20. Broomhead, D.S. and D. Lowe.
Multivariate Functional Interpolation
and Adaptive Networks. Complex
Systems. Vol. 2. Champaign, IL:
Complex Systems Publications (1988).
21. Hwang, K., S. Mandayam, S.S. Udpa
and W. Lord. A Multiresolution
Approach for Characterizing MFL
Signatures from Gas Pipeline
Inspections. Review of Progress in
Quantitative Nondestructive Evaluation
[Brunswick, ME, July-August 1996].
Vol. 16A. New York, NY: Plenum Press
(1997): p 733-739.

Bibliography
McClelland, J.L. and D.E. Rumelhart.
Explorations in Parallel Distributed
Processing. Cambridge, MA: MIT Press
(1988).
Stanley, W.D. Digital Signal Processing.
Reston, VA: Reston Publishing (1975).
Strauts, E.J. Section 11, Electronic
Analysis Circuits for Eddy Current
Tests. Nondestructive Testing Handbook,
second edition: Vol. 4, Electromagnetic
Testing. Columbus, OH: American
Society for Nondestructive Testing
(1986): p 265-314.

Signal and Image Processing for Electromagnetic Testing 205

You might also like