MTEX 6.0.beta.4 4/2024
Pseudo 3d EBSD and Grain maps
With version 6.0, MTEX starts to support pseudo 3d EBSD data. This means that EBSD maps are no longer restricted to the xy-plane. For example it is now possible to consider EBSD maps that represent the three faces of a cube. To make this possible, multiple changes at the core of MTEX had to be introduced:
-
ebsd.pos
gives the position of the EBSD measurements and is of type vector3d - many grain properties like vertices
grains.V
, centroidgrains.centroid
or long axisgrains.longAxis
are now of type vector3d. -
ebsd.N
,grains.N
gives the normal direction of a EBSD map - it is not possible to merge EBSD maps with different normal direction into one variable
Free three dimensional plotting of EBSD maps, pole figures, etc.
- Plotting of EBSD and grain maps is now possible in 3d
- The alignment of x, y and z on the screen is now controlled by an object of type @plottingConvention. The code
would plot an EBSD map with its normal direction out of the screen and the y-vector pointing to north. * A default plotting convention can be stored directly in the EBSD or grain variable via
- The plotting convention can also be passed to any spherical plot. This allows e.g. to plot pole figures with an arbitrary direction pointing out of the screen.
- As consequence
'upper'
and'lower'
refers to the outOFScreen direction.
Interface to Neper Neper is an open source software package for 3d polycrystal generation and meshing. It is now possible to call Neper from within MTEX, simulate micro-structures, generated slices through a 3d volume and import those slices into MTEX. Have a look at NeperInterface for more information.
MTEX 5.11.0 3/2024
MTEX 5.11 will be the last release before MTEX 6.0. It significantly improves grain reconstruction from 2d EBSD data.
Much Faster Grain Reconstruction
Thanks to using the jc_voronoi as tessellation method and some addition speedups grain reconstruction is now more than 10 times faster then previously. The method used for Voronoi tessellation is now specified in mtex_settings
by the option 'VoronoiMethod'
. You may want to set this option to 'qhull'
if you experience problems with the 'jcvoronoi'
engine.
Much Better Grain Reconstruction
With MTEX 5.11 MTEX uses alpha shapes to determine the shape of the grains in the presence of large unindexed regions. Those alpha shapes are controlled by a single parameter 'alpha'
with specifies to which extend indexed regions are allowed to grow into not indexed regions. Have a look at grain reconstruction for an illustration of the new method.
Vector Fields in Orientation Space
Functionality of Vector Fields in Orientation Space has been greatly extended. It includes now functions to compute the divergence div(vF)
, the curl curl(vF)
and the antiderivative of a vector field vF
on orientation space. This new functionality can be used to efficiently model texture evolution by numerically solving the continuity equation as it is demonstrated for the single slip model. Crucial for this approach is the new command doEulerStep
which updates an ODF or a list of orientation according to a vector field an orientation space which may be given e.g. by the Taylor model.
Lankford Parameter
The command calcLankford
allows for the computation of the Lankford or R-value. A full discussion of the corresponding analysis can be found here.
Transformation ODF
The command variants(p2c,odfParent)
takes now as a second input a parent ODF and return the child ODF under the assumption that all variants appear with the same frequency. This is in more detail explained in the section Transformation Texture.
Inner Planes in Crystal Shapes
Using the commands plotInnerFace
, plot(cS,sS)
and arrow3d
it is now possible to plot internal lattice planes, directions or slip systems into the crystal shape. This is explained in more detail at Crystal Shapes.
Numerous minor improvements and bug fixes
- new command
transformReferenceFrame(odf,csNew)
that allows to switch between different setups of the same symmetry, i.e. between 121 and 112. - improved h5 interface
- new function
cor(odf1,odf2)
to compute the correlation between two ODFs. - new function
lineIntersect
to compute the intersection between a line and a plane. - new class
S1Fun
to represent directional properties in the plane. - new function
volume(S2F,center,radii)
to compute the volume of a spherical function within a ball. - replaces
CLim
bysetColorRange
-
calcParentEBSD
computes also the variant and packet ids - many bug fixes
MTEX 5.10.1 9/2023
This is mainly a bug fix release.
MTEX 5.10.0 5/2023
Weighted Burgers Vector
With the function weightedBurgersVec(ebsd)
it is now possible to compute the weighted burgers vector both, using the integral approach as well as the differential approach.
Bain Group Determination
The function calcVariantId
now returns an id for the variant, the packet and the Bain group. The usage of this function is demonstrated here.
Numerous minor addon, speed improvements, bug fixes
- New option
'max'
toangle(mori)
to compute the largest misorientation angle. Helpful for identifying twinning. - Added checks for symmetry and positive definiteness when defining stress, strain and elasticity tensors.
- Add morphological filter
erode(ebsd)
as a simple method for data cleaning in EBSD maps. - Pseudesymmetries like 532 are now natively supported using the syntax
crystalSymmetry('532')
-
symmetrise(t,'iso')
return the isotropic portion of a tensor -
symmetricDecomposition
computes the symmetric decomposition of a tensor - normalize the Taylor factor according to the strain
- display boundary length as default output
- better import of h5 files
- many more fixes and speed improvements
MTEX 5.9.0 2/2023
Habit Plane Detection
MTEX 5.9 includes powerful functions for the determination of predominant habit planes and habit plane distributions. For the setting of a fully transformed microstructure the are described in the paper plane determination from reconstructed parent phase orientation maps. Those functions include
- new function
calcTraces(grains)
andcalcTraces(ebsd)
to compute habit plane traces from families of grains or EBSD data. - new function
calcGBND(traces,ori)
to compute the grain boundary normal distribution from a list of habit plane traces and the corresponding grain orientations. - new function
characteristicShape(gB)
to compute the characteristic shape from lists of grain boundaries
Orientation dependent functions
The orientation distribution function (ODF) describes the relative volume of crystal orientations within a material. As such it is a function that associates to each orientation a number with unit mrd (multiples of random distribution). However, in material science many other orientation depended functions are of importance, e.g., the Taylor factor with respect to some outer strain depends on the local orientation. While ODFs have ever since been at the heart of MTEX, this release is the first one that includes full support for orientation dependent functions. Those functions are called SO3Fun and behave similar to spherical functions S2Fun. In particular one can
- add, subtract, multiply and divide with them
- compare them
- detect global and local extrema
- visualize them in 3d and 2d sections
- compute gradients
While implementing these new features we also significantly speed up all operations related with ODF operations. A full documentation of these new features can be found here.
MTEX 5.8.2 11/2022
This is mainly a bug fix release. New functionalities include
-
fibre.fit(ori)
andfibre.fit(odf)
robustly finds fibers in data sets of individual orientations and ODFs. -
angle(f1,f2)
computes the angle between two fibers. -
calcSymAxis(pf)
allows to find rotational symmetries in pole figures or arbitrary spherical functions.
MTEX 5.8.0 01/2022
MTEX 5.8 improves further on parent grain reconstruction by implementing the novel variant graph algorithm which is faster and more accurate than the previous grain graph algorithm.
Improved parent grain reconstruction
Along with the new reconstruction algorithm the following new features have been implemented:
- manual interactive parent orientation selection using
selectInteractive(job)
- new option
'reconsiderAll'
in <parentGrainReconstructor.calcGBVotes.htmlcalcGBVotes(job)
to recheck all assignments of parent orientations. - new option
'bestFit'
in <parentGrainReconstructor.calcGBVotes.htmlcalcGBVotes(job)
to consider only the best fitting neighbor -
job.votes
is now a table which contains the parentId votes and the probabilities for all grains
Misc Changes
- new option
'region'
forplot(ebsd)
to plot only a rectangular subregion of the map
MTEX 5.7.0 05/2021
MTEX 5.7 improves on parent grain reconstruction. Changes include:
Improved parent grain reconstruction
- The ordering of the variants is stored within the OR misorientation
p2c
asp2c.variantMap
. In particular the variants inp2c.variants
are ordered by default according to the Morito convention. This can be easily check by the commandround2Miller(p2c.variants)
- The command
job.calcGBVotes
andjob.calcTPVotes
compute votes associated with probabilities that are stored injob.votes
and can easily be analyzed. - The options
'noP2C'
and'noC2C'
have been replaced by'p2c'
and'c2c'
. - New option
job.useBoundaryMisorienation
which makes the parent grain reconstructor to use the misorientations along the grain boundaries instead of the misorientations between the grain mean orientations. - added ShojiNishiyama orientation relationship.
Other Changes
- The command
findByOrientation
accepts a fiber as input. - The antipodal
axisAngleColorKey
allows for option'antipodal'
.
MTEX 5.6.1 03/2021
This is mainly a bug fix release.
MTEX 5.6.0 01/2021
MTEX 5.6 greatly simplifies parent grain reconstruction by introducing the class parentGrainReconstructor
. During the reconstruction procedure this class keeps track of the correspondence between measured child grains and the reconstructed parent grains. It provides the following functions for recovering parent orientations which can be applied multiple times and in any order to achieve the best possible reconstruction.
-
calcParent2Child
- optimize parent to child orientation relationship -
calcGBVotes
- compute votes from child/child and parent/child grain boundaries -
calcTPVotes
- compute votes from child/child/child triple points -
job.calcParentFromVote
- recover parent orientations from votes -
job.calcParentFromGraph
- recover parent orientations from graph clusteres -
job.mergeSimilar
- merge similar parent grains -
job.mergeInclusions
- merge inclusions -
job.revert
- undo parent grain reconstructions
The usage of this new class is demonstrated in Beta Titanium Reconstruction and Parent Martensite Reconstruction.
Compatibility fixes
MTEX 5.6 fixes several incompatibilities with MATLAB versions earlier then 2019b.
MTEX 5.5.0 11/2020
Orientation Embedding
Orientational embeddings are tensorial representations of orientations with the specific property that each class of symmetrically equivalent orientations has a unique tensor representation. In contrast to the well known representation by Rodrigues vectors those embeddings do not suffer from boundary effects, i.e., the Euclidean distance between the tensors is always close to the misorientation angle. This allows to lift any method that works for multivariate data to orientations. More details of this representation can be found in the chapter orientation embeddings and the paper
- R. Hielscher, L. Lippert, Isometric Embeddings of Quotients of the Rotation Group Modulo Finite Symmetries, arXiv:2007.09664, 2020.
Low Angle Boundaries
With MTEX 5.5 we make low angle grain boundary analysis much more straight forward by allowing to pass to the command calcGrains
two thresholds, i.e.,
generates grains bounded by high angle grain boundaries with a threshold of 10 degree and inner low angle boundaries with an threshold of 1 degree. The latter ones are stored as grains.innerBoundary
. In order to estimate the density of inner boundaries per grain the commands subBoundaryLength
and subBoundarySize
have been introduced. The documentation page Subgrain Boundaries describes the analysis of low angle boundaries in more detail.
New Functionalities
- For single phase EBSD maps you can access the orientations now more easily by
ebsd.orientations
instead ofebsd('indexed').orientations
. Orientations corresponding to not indexed pixels will be returned as NaN and thus automatically ignored during any further computation. -
grains.isBoundary
checks grains to be boundary grains -
grains.isInclusion
checks grains to be inclusions -
merge(grains,'inclusions')
merges inclusions into their hosts -
merge(grains,'threshold',delta)
merges grains with a certain misorientation angle - interpolation of EBSD maps at arbitrary coordinates by the command
interp
works now for hexagonal grids as well. In particular this allows to remap EBSD data from hexagonal to square grids and vice versa. Have a look at the chapter Interpolation for more details. -
calcMis2Mean
computes the misorientation to a grain reference orientation, i.e., the grain reference orientation deviation (GROD). - KAM computation has been speed up significantly for hexagonal and square grids. Make sure to use the command
ebsd = ebsd.gridify
before the KAM computation. - new option
'edgeAlpha'
to control the transparency of grain boundaries, e.g. in dependency of the misorientation angle. - more easily add new / change phases in an EBSD map by one of the following commands
- new option to plot arrows in spherical plots by
-
export(ebsd,fileName)
allows to export to EBSD data to.ang
,.ctf
,.crc
and.hdf5
files, thanks to Azdiar Gazder - new function
rot = fit(l,r)
to compute the rotations that best rotates all the vectorsl
onto the vectorsr
-
orientation.load
andvector3d.load
allows now to import additional properties.
Important Bug Fixes
-
volume(odf)
gave wrong results in the presence of specimen symmetry and for centers close to the boundary of the fundamental region.
-
slipSystem.symmetrise
gave incorrect number of slipsystems due to a rounding error
MTEX 5.4.0 7/2020
Parent Grain Reconstruction
MTEX now includes a number of functions for variant analysis and to recover parent grain structure. Examples include beta phase reconstruction in Titanium and Martensite reconstruction from Austenite grains. The reconstruction is mainly build around the following new commands
-
calcParent
computes the best fitting parent orientations from child orientations -
calcChildVariants
separates child variants into packets -
calcParent2Child
computes best fitting parent to child orientation relationship from child to child misorientations -
variants
computes all parent or child variants
New Functionalities
- new function
ebsd.interp
to interpolate EBSD maps at arbitrary x,y coordinates, example -
smooth(grains)
keeps now triple points and outer boundary fixed by default - the field
grains.triplePoints.angles
returns the angles between the boundaries at the triple points - new option
'removeQuadruplePoints'
tocalcGrains
- harmonic approximation of spherical functions respecting symmetry
-
export(ebsd,'fileName.ang')
exports to .ang files -
neighbours(grains)
now returns a list of pairs of neighboring grains -
grains.numNeighbours
returns the number of neighboring grains -
selectByGrainId
allows to select boundary segments by pairs of grains - new helper function
majorityVote
- new option
'noAntipodal'
for many commands likesymmetrise
,unique
,dot
,angle
- new predefined orientation relationship
orientation.Burgers
MTEX 5.3.1 6/2020
New Functions
- interp to interpolate EBSD maps
- grain properties longAxis, shortAxis
- grain boundary curvature
Bug Fixes
- loading ang files
- importing ODFs
- inverse pole figures misses orientations
- convex hull of grains has now correct boundaries
- Other Changes*
- vector3d/mean now returns not normalized vectors
- new flag
noAntipodal
to supress antipodal symmetry in calculations
MTEX 5.3.0 4/2020
MTEX 5.3 is a humble release without big shiny improvements. On the other hand is has seen some internal changes which lead to significant speed improvements in some functions. Technically speaking the class symmetry is not derived from rotation anymore but is a handle class. From the users perspective almost no change will be noticed. Developers should replace length(cs)
by numSym(cs)
.
Much Better and Faster Halfquadratic Filter
Denoising of EBSD data using the halfQuadraticFilter
is now about 10 times faster, handles outliers much better and runs native on hexagonal grids.
New Functions
-
plotWaveVelocities
illustrates anisotropy of seismic waves -
grainMean
grain averages of arbitrary properties - shape functions
surfor
,paror
,caliper
-
multiplicity
for Miller, orientation and fiber
MTEX 5.2.3 11/2019
- replaced
calcODF(ori)
bycalcDensity(ori)
- bug fix in ODF reconstruction from XRD data
- bug fix in EBSD export to ctf
- bug fix in grain reconstruction
- some more minor bug fixes
MTEX 5.2.0 10/2019
New Documentation
MTEX got a new homepage which was needed to include a much more exhaustive online documentation which has now
- a sidebar for quick navigation
- a search field
- a complete function reference to all MTEX functions and classes
- UML diagrams illustrating the hierarchy of the classes
- much more content
The new documentation is not yet perfect though we are working hard to improve it. That's why we are extremely happy for everybody who contributes additions to the documentation. This includes the correction of spelling errors, theoretical parts, examples etc. Check out how to contribute to the documentation.
More Colors
All plotting commands in MTEX support now much more colors. By default all the color names of the CSS palette can be chosen, e.g., aqua, orange, gold, goldenrod, etc. To see a full list of supported colors do
colornames_view
The following function have been included to handle colors more efficiently
Improved Import Wizard
Importing EBSD data using the import wizard allows to interactively realign the data and check with respect to the pole figures.
Speed Improvements
- much faster visualization of the large EBSD maps if
gridify
is used - faster Fourier transforms on the sphere and the orientation space
- support for <MOSEK https://docs.mosek.com/9.0/toolbox/install-interface.html> as faster replacement for linprog from the Optimization Toolbox
Support for hexagonal EBSD grids
The function gridify
now works also for EBSD data measured on a hexagonal grid. As a consequence denoising and GND computation for those data is also on the way.
Plastic Deformations
MTEX 5.2. introduces a bunch of new tensor classes to make modelling of plastic deformations more straight forward.
The relationships between those tensors are explained in the section plastic deformations.
Spherical Bingham Distribution
Native support for spherical Bingham distributions, including the ability to fit them to directional distributions.
Tensors
- Improved methods for the visualization of elastic properties, see Seismic demo
- several new functions like
trace
,svd
,det
, double dot product:
- the function
mean
computes now Voigt, Reuss, Hill and geometric means
Improved Figure Layout
- fix layout
- plot at fixed positions
Misc Changes
- allow to export EBSD data to
.ctf
thanks to Frank Niessen - compute the volume of a crystal shape
- label crystal faces in crystal shapes
- new function
std
for computing the standard deviation of orientations - new function
calcKearnsFactor
-
grainBoundary.ebsdId
is now the id and not the index of the EBSD data - allow to index ebsd data and grains by id using
{}
brackets
- new options to scatter
MTEX 5.1.0 04/2018
Dislocation systems
Starting with version 5.1 MTEX introduces a class representing dislocation systems. Dislocation systems may be lists of edge or screw dislocations and are either defined by its burgers and line vectors
by a family of slipsystems
or as the family of predefined dominant dislocation systems by
More information how to calculate with dislocation systems can be found here.
Geometrically neccesary dislocations
The newly introduced dislocation systems play an important role when computing geometrically neccesary dislocations from EBSD data. The workflow is illustrate the script GND and consists of the following steps:
- define the dominant dislocation systems
- transform the dislocation systems into specimen coordinates for each pixel of the EBSD map
- compute the curvature tensor for each pixel in the EBSD map
- fit the dislocation systems to the curvature tensors.
- compute the total energy in each pixel
Tensor arithmetics
dyad
, trace
, det
, mean
, diag
, eye
, sym
Birefringence
MTEX 5.1 includes some basic methods to analyze and simulate optically isotropic materials. This includes the computation of the optical axis, birefringence and spectral transmission. The new features are demonstrated in BirefringenceDemo.
Color Keys
In MTEX 5.1 the color keys used for coloring EBSD have been a bit reorganised.
- seperate classes for directional color keys. So far these classes are
HSVDirectionKey
,HKLDirectionKey
,TSLDirectionKey
. This has become neccesary as some orientation color keys depend directional color keys with different symmetry.
- new color key
axisAngleColorKey
that implements the coloring described in K. Thomsen, K. Mehnert, P. W. Trimby and A. Gholinia: Quaternion-based disorientation coloring of orientation maps, Ultramicroscopy, 2017. In central idea is to colorise the misorientation axis with respect to the specimen reference system.
- The existing color keys have been renamed for better consistency. The new names are
BungeColorKey
,ipfHSVKey
,ipfHKLKey
,ipfTSLKey
,ipfSpotKey
,spotColorKey
,PatalaColorKey
Spherical functions
- new function
discreteSample
to compute random samples from spherical density functions - new option to
symmetrise
to symmetrise a spherical function with respect to an axis
Misc
- new fuction
fitEllipse
to assign ellipses to grains - the functions
symmetrise(tensor)
andsymmetrise(S2F)
do support symmetrisation with respect to a certain axis. - the function
export(ori)
allows to export arbitrary additional properties together with the Euler angles, e.g. the half axes and orientation of the grain ellipses - the function
loadOrientation_generic
allows to import arbitrary additional properties together with the orientations, e.g., weights - new option
logarithmic
- new function
grad
to compute the gradient of and ODF at a certain orientation - explicitely set the number of rows and columns in a MTEXFigure plot with
- EBSD hdf5 interface works now for Bruker data as well
MTEX 5.0.0 03/2018
Replace all executables by two mex files
In MTEX many functionalities are based on the non equispaced fast Fourier transform (NFFT). Until now this dependency was kept under the hood, or more precisely, hidden in external executable files which often caused troubles on MAC systems. Starting with MTEX 5.0. all the executables have been replaced by two mex files provided by the NFFT package. This change (hopefully) comes with the following advantages
- better compatibility with MAC systems, no SIP disabled required
- increased performance, e.g., due to multi core support
- better maintainability, as all MTEX code is now Matlab code
- the pole figure to ODF inversion algorithm is now entirely implemented in Matlab making it simple to tweak it or add more sophisticated inversion algorithms
Spherical functions
Many functions in MTEX compute directional dependent properties, e.g. pole figures, inverse pole figures, wave velocities, density distribution of misorientation axis or boundary normals. Until now those functions took as an input an of vector of directions and gave as an output a corresponding vector of function values, e.g. the command
returns for a list of specimen directions r
the corresponding list of pole figure intensities pfi
for the ODF odf
. Starting with MTEX 5.0 it is possible to ommit the list of specimen directions r
or replace it by an empty list []
. In this case the command
returns a spherical function pdf
also called pole density function. One can evaluate this spherical function using the command eval at the list of specimen directions r
to obtain the pole figure intensities
However, there are many more operations that can be performed on spherical functions:
For a complete list of functions read here.
Symmetry aware spherical functions
Since most of the directional dependent properties obey additional symmetry properties the class S2FunHarmonic has been extended to respect symmetry in the class S2FunHarmonicSym.
Multivariate spherical functions, vector fields and spherical axis fields
In some cases it is useful that a spherical function gives not only one value for a certain direction but several values. This is equivalent to have concatenate several univariate spherical function to one multivariate function. This can be accomplished by
which gives a spherical function with 3 values per direction. More information how to work multivariate functions can be found here.
If we interpret the 3 values of S2Fmulti
as \(x\), \(y\), and, \(z\) coordinate of a 3 dimensional vector, the function S2Fmulti
can essentially be seen as a spherical vector field associating to each direction a three dimensional vector. The most important example of such a vector field is the gradient of a spherical function:
The resulting variable g
is of type S2VectorField. A complete list of functions available for vector fields can be found here.
Another example for vector fields are polarisation directions pp
, ps1
, ps2
as computed by
The main difference is, that polarisation directions are antipodal, i.e. one can not distinguish between the polarisation direction d
and -d
. In MTEX we call vector fields with antipodal values are represented by variables of type AxisField.
Scalar tensor properties are returned as spherical functions
Any scalar or vectorial property of a tensor is not returned as a spherical function or spherical vector field. Examples are the velocity properties mentioned above, Youngs modulus, shear modulus, Poisson ration etc. In particular, plotting those directional dependend quantities is as simple as
This makes the old syntax
obsolete. It is not supported anymore.
Crystal shapes
MTEX 5.0 introduces a new class crystalShape. This class allows to plot 3-dimensional representations of crystals on top of EBSD maps, pole figures and ODF sections. The syntax is as follows
ODF component analysis
MTEX 5.0 allows for decomposing ODF into components using the command calcComponents. In its simplest form
returns a list of modal orientaions mods
and a list of weights which sum up to one. A more advanced call is
which returns in centerId also for each orientation from oriList
to which component it belongs.
Clustering of orientations
The ODF component analysis is used as the new default algorithm in calcCluster for orientations. The idea is to compute an ODF out of the orientations and call calcComponents with
Then center
are the clusters center and centerId
gives for each orientation to which cluster it belongs. Substantional in this method is the choise of the kernel halfwidth used for ODF computation. This can be adjusted by
New tensor classes
With MTEX 5.0 we start introducing specific tensor classes. So far we included the following classes
more tensors are supposed to be included in the future. The central advantage is that tensor specific behaviour and functions can now better be implemented and documented, e.g., that the inverse of the compliance tensor is the stiffness tensor and vice versa. For user the important change is that e.g. the stiffness tenssor is now defined by
instead of the depreciated syntax
Improved spherical plotting
In MTEX 4.X it was not possible to display the upper and lower hemisphere in pole figure plots, inverse pole figure plots or ODF section plots. This was a server restriction as for certain symmetries both hemispheres do not have to coincide. In MTEX 5.0 this restriction has been overcome. MTEX automatically detects whether the upper and lower hemisphere are symmetrically equivalent and decides whether both hemispheres needs to be plotted. As in the previous version of MTEX this can be controlled by the options upper
, lower
and complete
.
As a consequence the behaviour of MTEX figures have changed slightly. By default MTEX now always plots into the last axis. In order to annotate orintations or directions to all axes in a figure use the new option add2all
.
plotIPDF(SantaFe,[xvector,yvector+zvector]) [~,ori] = max(SantaFe) plot(ori,'add2all')
We also introduced two new functions plotSection and quiverSection to visualize spherical functions restricted to a plane. As an exaple one can now plot the slowness surfaceses of wave velocities in the plane perpendicular to Y with
see here for more information.
Other new functions
- odf.grad computes the gradient of an ODF at some orientation
- grain2d.hist can now plot histogram of arbitrary properties
-
fibreVolume
works also for specimen symmetry - allow to change the length of the scaleBar in EBSD plots
MTEX 4.5.2 11/2017
This is mainly a bug fix release
- some more functions get tab completetion for input arguments
- the option 'MarkerSize' can also be a vector to allow for varying Markersize
- new option 'noSymmetry' for plotPDF and plotSection
orientation relation ships
- new functions for computing variants and parents for a orientation relation ship *
- new predefined orientation relation ship
MTEX 4.5.1 08/2017
This is mainly a bug fix release
- some functions get tab completetion for input arguments
- allow different colormaps in one figure
- updated interfaces
- added Levi Civita permutation tensor
- improved round2Miller
- grains.boundary('phase2','phase1') rearranges the misorientation to be from phase2 to phase 1
MTEX 4.5 03/2017
3d orientation plots
MTEX 4.5 supports plotting of orientations, fibres, and ODFs in 3d in various projections like
- Bunge Euler angles
- Rodrigues Frank space
- axis angles space
Misorientations
- MTEX introduces round2Miller which determines to an arbitrary misorientation
mori
two pairs of lower order Miller indeces such that which are aligned bymori
- MTEX includes now some of the important misorientation relationsships like
Grain Reconstruction
New option to handle non convex other shapes of EBSD data sets
- Grain boundary indexing* The commands gB('phase1','phase2').misorientation returns now always a misorientation from phase1 to phase2
Tensors
EBSD
Rotating, flipping of EBSD data is now done with respect to the center of the map. Previously all these opertions where done relatively to the point (0,0). Use
to get back the behavior of previous versions.
Colorbar
MTEXColorbar
allows now to have a title next to it. Use
Bug Fix This release contains several important bug fixes compare to MTEX 4.4.
MTEX 4.4 01/2017
Slip Systems
MTEX 4.4 introduces support for slip systems. Slip systems are defined by a plane normal and a slip direction
Slip systems are instrumental for computating the following properties
Fibres
MTEX 4.4 adds support for fibres in orientation space. As an example the alpha fibre in cubic materials can be defined in the following ways
- as a predefined fibre
- by a pair of directions
- by two orientations
- by a list of orientations
All commands that took a pair of directions to specify a fibre, e.g., fibreODF, fibreVolume, plotFibre have been rewritten to accept a fibre as a single input argument. I.e. a fibre ODF is now defined by
Up to now the following functions are implemented for fibres
- plot to Rodrigues space, Euler space, pole figures, inverse pole figures
oR = fundamentalRegion(cs,cs) f = fibre(oR.V(1),oR.V(2)) plot(oR) hold on plot(fibre,'color','r','linewidth',2) hold off
- compute the angle between orientation and fibre
Ignore Symmetry
Many functions support now the flag noSymmetry
. Among them are angle
, axis
, dot
, cunion
.
Clustering of orientations
The new command calcCluster allows to cluster a given set of orientations into a given number of clusters.
MTEX 4.3.2 07/2016
Alignment of Miller plots
You can now specify the alignment of the crystal a-axis or b-axis in Miller plots by
This might also be specify in mtex_settings.m mtex_settings.
MTEX 4.3 - 03/2016
Alignment of Miller plots
Starting with MTEX 4.3 plots with respect to the crystal coordinate system, i.e., inverse pole figure plots, misorientation axis plot, ipf keys, are always aligned such that the b-axis points towards east. This follows the convention given in the International Table of Crystallography. The alignment can be adjusted using the option xAxisAlignment
Plotting vector fields at grain centers or grain boundaries
There are three new commands
that allow visualizing directions for EBSD data, grains and at grain boundaries. The input argument dir
should be a list of vector3d
and may represent e.g. slip directions, polarization direction, etc.
EBSD data in raster format
Until MTEX 4.2 EBSD data have been always considered as a one-dimensional list of data, i.e., the often present structure of a regular grid was completely ignored. Starting with MTEX 4.3 EBSD data can be converted in a regular grid by
Missing data are represented as NaN in the regular representation. Gridified EBSD data may be addressed analogously like matrixes, i.e.,
will give pixel 100 in the y-direction and 200 in the x-direction. Analogously.
will give the stripe if pixels with y coordinate between 50 and 100.
Orientation gradients and GND
Gridified EBSD data allows also to compute orientation gradients by
as well as an estimate of the geometrically necessary dislocation density (GND) using the command calcGND
Auxilary new functionality
- grain2d.calcParis - Percentile Average Relative Indented Surface
- tensor.diag
- reduce works now also for EBSD data on Hex grids
MTEX 4.2 - 11/2015
MTEX 4.2 introduces basic functionality for triple junction analysis in grain maps.
Triple points
Triple points are automatically computed during grain reconstruction and can be accessed by
More details on how to work with triple points can be found here.
large EBSD data sets
Analyzing large EBSD data sets may be quite annoying due to memory consumption and slow plotting. As a work around MTEX includes a new function reduce which allows reducing the data set to each n-th pixel, i.e.,
contains only 25 percent of the data of the original data set. This functionality is assumed to be used for experimenting around with the data set and setting up a proper analysis script. The final analysis should, if possible, be done with the entire data set.
New option to ignore symmetry
When computing the angle between crystal directions, the misorientation angle between orientations and the misorientation axis symmetry can be ignored with the flag noSymmetry
Axis distributions in specimen coordinates
In order to plot axis distributions in specimen coordinates, you can now do
or
New option to work around Matlab opengl bug
In mtex_settings.m mtex_settings there is a new option that may help to work around the Matlab opengl bug. Switching it of may give nicer graphics.
CSL misorientations
The function CSL requires now as a mandatory argument the crystal symmetry of the phase, i.e.
Grain boundaries
Grain boundaries segments have a new option midPoint
which may be used for attaching a vector displaying the misorientation axis or some other direction.
More ODF sections
- phi1
- Phi
- gamma
- omega
Along with the old syntax, there is now a new syntax that allows for more fine control of the ODF sections.
Ordering of crystal symmetries
One can now check whether a crystal symmetry cs1
is a subgroup of crystal symmetry cs2
by
Further, the largest proper subgroup of some crystal symmetry cs
is now accessible by
cs.properSubGroup
MTEX 4.1 - 09/2015
MTEX 4.1 introduces new possibilities to the analysis of misorientations. For the first time, it covers all geometric aspects of misorientations between arbitrary crystal symmetries. Furthermore, MTEX 4.1 introduces filters to smooth EBSD data.
Smoothing of EBSD Data
Smoothing of EBSD data might be necessary if the orientation data are corrupted by noise which influences the estimation of orientation dependent properties like KAM or GND. The general syntax for smoothing EBSD data is
This applies the spline filter to the orientation data. Beside the spline filter, many other filters are available. A general discussion on this topic can be found here. To make use of a different than the default filter use the syntax
The command smooth can also be used to fill not indexed measurement points. This behavior is enabled by the option fill
Support for antipodal symmetry for misorientations
When working with boundary misorientations between the same phase one can not distinguish between a misorientation mori
and its inverse |inv(mori). Starting with MTEX 4.1 this symmetry is supported for misorientations and misorientation distribution functions.
Antipodal symmetry effects the asymmetric region in orientation space as described below, as well as the distance between misorientations. Boundary misorientations between the same phase have set the flag antipodal
by default.
Asymmetric regions in orientation space
MTEX 4.1 has now full support of asymmetric regions in orientation space. For any combination of crystal symmetries they can be defined by
and visualized by
One can check, whether an orientation is within the fundamental region by
similarly as for a sphericalRegion. The fundamental region with antipodal symmetry is defined by.
For a fixed rotational angle omega
, the intersection of the fundamental region with the sphere with radius omega gives the fundamental sector for the corresponding rotational axes. The axis sector can be computed by
Axis and angle distributions
Thanks to the implementation of the asymmetric region plotAxisDistribution
and plotAngleDistribution
works in MTEX 4.1 for any combination of crystal symmetries.
The following syntax is obsolete
As replacement use the more verbose syntax
Rotational axis in specimen coordinates
It is now possible to compute the misorientation axis between two orientations in specimen coordinate system. This is done by
To do so with random misorientations from an EBSD data set do
Axis angle plots
(Mis)Orientation, ODFs, and MDFs can now be plotted in axis angles sections. Those plots respect the fundamental sector depending on the misorientation angle and for all combinations of crystal symmetries. The angle sections are scaled such that they represent the corresponding volume in orientation space. This can be switch off as described below
Replace plotODF by a plotSection
In most cases, you can replace plotODF
by a|plot|. Only for misorientations, the default plot is scattered
.
More default settings for EBSD maps and pole figure plots
- new MTEXpref to show/hide the micronbar in EBSD maps. The default is set in
mtex_settings.m
toon
. The following command switches them off.
- new MTEXpref to show/hide the coordinates in EBSD maps. The default is set in
mtex_settings.m
tooff
. The following command switches them on.
- new MTEXpref to display coordinates in pole figure plot. The default is set in
mtex_settings.m
to display the directionsX
andY
. The following command switches it toRD
andND
.
Other improvements since MTEX 4.0.0
During the minor revisions of MTEX also several minor improvements have been added which are summarized below
- check for inclusions in grains: the following command returns a list of true/false depending whether a grain in
grainList
is an inclusion inhostGrain
- allow syntax
- allow to show / hide the scale bar by the MTEX menu or by
- allow to place labels above/below the marker by
- new EBSD interface to ACOM Nanomegas *.ang files
- plot relative to the crystal coordinate system are now always aligned such that x points to the east and y points to north
- misorientation axis with respect to crystal and specimen reference frame
- new function
intersect
to compute intersections between grain boundary segments an a line
- option for plotting angle distributions in percent
- reintroduced min/max in pole figure like plot
- 3d plots of pole figures can now be simultanously rotated
- you can now restrict an EBSD data set to a line to plot profiles
- additional syntax to define a list if Miller indices
- interface to Bruker phl files
- new properties for grainBoundary
gB
- for a crystal symmetry
cs
you can access a, b ,c and reciprocal axes by
- compute KAM with misorientation angle threshold or grain boundary threshold
MTEX 4.0.0 - 10/2014
MTEX 4 is a complete rewrite of the internal class system which was required to keep MTEX compatible with upcoming Matlab releases. Note that MTEX 3.5 will not work on Matlab versions later than 2014a. As a positive side effect, the syntax has been made more consistent and powerful. On the bad side MTEX 3.5. code will need some adaption to run on MTEX 4. There are two general principles to consider
Use dot indexing instead of getting and setting methods
The syntax
is obsolete. set
and get
methods are not longer supported by any MTEX class. Instead use dot indexing
Note, that this syntax can be nested, i.e., one can write
to get the rotational angle of all Forsterite orientations, or,
to get the x coordinate of the first crystallographic coordinate axis - the a-axis. As a nice bonus, you can now use TAB completion to cycle through all possible properties and methods of a class.
Use camelCaseCommands instead of under_score_commands
Formerly, MTEX used different naming conventions for functions. Starting with MTEX 4.0 all function names consisting of several words, have the first word spelled with lowercase letters and the consecutive words starting with a capital letter. Most notable changes are * |plotPDF| * |plotIPDF| * |plotODF| * |calcError|
Grain boundaries are now directly accessible
MTEX 4.0 introduces a new type of variables called grainBoundary
which allows to represent arbitrary grain boundaries and to work with them as with grains. The following lines give some examples. Much more is possible.
Plotting EBSD, grain, grainBoundary data has different syntax
The syntax of the plot commands has made more consistent throughout MTEX. It is now
where obj is the object to be plotted, i.e., EBSD data, grains, grain boundaries, spherical vectors, pole figures, etc., and the data are either pure numbers or RGB values describing the color. Examples are
Colorization according to phase or phase transition is the new default when calling plot
without data argument, i.e., the following results in a phase plot
In order to colorize ebsd data according to orientations, one has first to define an orientationMapping by
Then one can use the command oM.orientation2color
to compute RGB values for the orientations
The orientation mapping can be visualized by
EBSD data are always spatially indexed
Starting with MTEX 4.0 EBSD data always have to have x and y coordinates. EBSD data without spatial coordinates are imported simply as orientations. As a consequence, all orientation related functionalities of EBSD data have been moved to orientations
, i.e., you can not do anymore
But instead you have to explicitly state that you operate on the orientations, i.e.
This makes it more easy to apply the same functions to misorientations to grain mean orientations grains.meanOrientation
, ebsd misorientation to mean mean |ebsd.mis2mean
or boundary misorientations grains.boundary.misorientation
Different syntax for reconstructing grains from EBSD data
In MTEX 3.5 the command
duplicates the ebsd data into the grain variable allowing to access the EBSD data belonging to a specific grain by
In MTEX 4.0 the command calcGrains
returns as an additional output the list of grainIds that is associated with the EBSD data. When storing these grainIds directly inside the EBSD data, i.e., by
one can access the EBSD data belonging to a specific grain by the command
MTEX 4.0 distinguishes between crystal and specimen symmetry
In MTEX 4.0 two new variable types specimenSymmetry
and crystalSymmetry
have been introduced to distinguish clearly between these two types of symmetry. Calling
is not allowed anymore! Please use instead
Pole figure indexing is now analogously to EBSD data
You can now index pole figure data by conditions in the same manner as EBSD data. E.g. the condition
is an index to all pole figure data with a polar angle smaller than 80 degree. To restrict the pole figure variable pf
to the data write
In the same manner, we can also remove all negative intensities
In order to address individual pole figures within a array of pole figures pf
use the syntax
or
The old syntax
for accessing the first pole figure will not work anymore as it now refers to the first pole figure measurement. The direct replacement for the above command is
MTEX 4.0 supports all 32 point groups
In MTEX 4.0 it is for the first time possible to calculate with reflections and inversions. As a consequence, all 32 point groups are supported. This is particularly important when working with piezoelectric tensors and symmetries like 4mm. Moreover, MTEX distinguishes between the point groups 112, 121, 112 up to -3m1 and -31m.
Care should be taken, when using non-Laue groups for pole figure or EBSD data.
Support for three-digit notation for Miller indices of trigonal symmetries
MTEX 4.0 understands now uvw and UVTW notation for trigonal symmetries. The following two commands define the same crystallographic direction, namely the a1-axis
Improved graphics
MTEX can now display colorbars next to pole figure, tensor or ODF plots and offers much more powerful options to customize the plots with titles, legends, etc.
Functionality that has been (temporarily) removed
This can be seen as a todo list.
- 3d EBSD data handling + 3d grains
- some grain functions like aspectRatio, equivalent diameter
- logarithmic scaling of plots
- 3d plot of ODFs
- some of the orientation color maps
- fibreVolume in the presence of specimen symmetry
- Dirichlet kernel
- patala colorcoding for some symmetry groups
- v.x = 0
- misorientation analysis is not yet complete
- some colormaps, e.g. blue2red switched
- histogram of volume fractions of CSL boundaries
- remove id from EBSD?
- changing the phase of a grain should change phases in the boundary
- KAM and GOSS may be improved
- write import wizard for orientations, vectors, tensors.
MTEX 3.5.0 - 12/2013
Misorientation colorcoding
- Patala colormap for misorientations
- publication: S. Patala, J. K. Mason, and C. A. Schuh, Improved representations of misorientation information for grain boundary, science, and engineering, Prog. Mater. Sci., vol. 57, no. 8, pp. 1383-1425, 2012.
- implementation: Oliver Johnson
- syntax:
Fast multiscale clustering (FMC) method for grain reconstruction
- grain reconstruction algorithm for highly deformed materials without sharp grain boundaries
- publication: C. McMahon, B. Soe, A. Loeb, A. Vemulkar, M. Ferry, L. Bassman, Boundary identification in EBSD data with a generalization of fast multiscale clustering, Ultramicroscopy, 2013, 133:16-25.
- implementation: Andrew Loeb
- syntax:
Misc changes
- one can now access the grain id by
- the flags
'north'
and'south'
are obsolete and have been replaced by'upper'
and'lower'
- you can specify the outer boundary for grain reconstruction in non-convex EBSD data set by the option
'boundary'
- you can select a polygon interactively with the mouse using the command
Bug fixes
- .osc, .rw1 interfaces improved
- .ang, .ctf interfaces give a warning if called without one of the options
convertSpatial2EulerReferenceFrame
orconvertEuler2SpatialReferenceFrame
- fixed: entropy should never be imaginary
- removed function
SO3Grid/union
- improved MTEX startup
- many other bug fixes
- MTEX-3.5.0 should be compatible with Matlab 2008a
MTEX 3.4.2 - 06/2013
bugfix release
- fixed some inverse pole figure color codings
- option south is working again in pole figure plots
- geometric mean in tensor averagin, thanks to Julian Mecklenburgh
- improved support of osc EBSD format
- tensor symmetry check error can be turned of and has a more detailed error message
- improved syntax for Miller Miller(x,y,z,'xyz',CS) Miller('polar',theta,rho,CS)
- ensure same marker size in EBSD pole figure plots
- allow plotting Schmid factor for grains and EBSD data
- allow to annotate Miller to AxisDistribution plots
- improved figure export
- allow for negative phase indices in EBSD data
- bug fix: https://code.google.com/p/mtex/issues/detail?id=115
- improved ODF fibre plot
MTEX 3.4.1 - 04/2013
bugfix release
- much improved graphics export to png and jpg files
- improved import wizard
- Miller(2,0,0) is now different from Miller(1,0,0)
- new EBSD interfaces h5, Bruker, Dream3d
- various speedups
- fix: startup error http://code.google.com/p/mtex/issues/detail?id=99
- fix: Rigaku csv interface
MTEX 3.4.0 - 03/2013
New plotting engine
MTEX 3.4 features a completely rewritten plotting engine. New features include
- The alignment of the axes in the plot is now described by the options
xAxisDirection
which can benorth
,west
,south
, oreast
, andzAxisDirection
which can beoutOfPlane
orintoPlane
. Accordingly, there are now the commands
- The alignment of the axes can be changed interactively using the new MTEX menu which is located in the menubar of each figure.
- northern and southern hemisphere are now separate axes that can be stacked arbitrarily and are marked as north and south.
- Arbitrary plots can be combined in one figure. The syntax is
- One can now arbitrarily switch between scatter, contour and smooth plots for any data. E.g. instead of a scatter plot the following command generates now a filled contour plot
- obsolete options:
fliplr
,flipud
,gray
,
Colormap handling
- User defined colormap can now be stored in the folder
colormaps
, e.g. asred2blueColorMap.m
and can set interactively from the MTEX menu or by the command
ODF
- The default ODF plot is now phi2 sections with plain projection and (0,0) being at the top left corner. This can be changed interactively in the new MTEX menu.
- The computation of more than one maximum is back. Use the command
EBSD data
- MTEX is now aware about the inconsistent coordinate system used in CTF and HKL EBSD files for Euler angles and spatial coordinates. The user can now convert either the spatial coordinates or the Euler angles such that they become consistent. This can be easily done by the import wizard or via the commands
- It is now possible to store a color within the variable describing a certain mineral. This makes phase plots of EBSD data and grains more consistent and customizable.
- A better rule of thumb for the kernel width when computing an ODF from individual orientations via kernel density estimation.
- inpolygon can be called as
Tensors
- new command to compute the Schmid tensor
- new command to compute Schmid factor and active slip system
- it is now possible to define a tensor only by its relevant entries. Missing entries are filled such that the symmetry properties are satisfied.
- faster, more stable tensor implementation
- new syntax in tensor indexing to be compatible with other MTEX classes. For a 4 rank thensor
C
, we have now
- For a list of tensors
C
we have
Import / Export
- command to export orientations
- command to import vector3d
- new interface for DRex
- new interface for Rigaku
- new interface for Saclay
General
- improved instalation / uninstalation
- new setting system
has been replaced by
MTEX 3.3.2 - 01/2013
bugfix release
- fix: better startup when using different MTEX versions
- fix: backport of the tensor fixes from MTEX 3.4
- fix: show normal colorbar in ebsd plot if scalar property is plotted
- fix: http://code.google.com/p/mtex/issues/detail?id=82
- fix: http://code.google.com/p/mtex/issues/detail?id=76
- fix: http://code.google.com/p/mtex/issues/detail?id=48
- fix: http://code.google.com/p/mtex/issues/detail?id=71
- fix: http://code.google.com/p/mtex/issues/detail?id=70
- fix: http://code.google.com/p/mtex/issues/detail?id=69
- fix: http://code.google.com/p/mtex/issues/detail?id=65
- fix: http://code.google.com/p/mtex/issues/detail?id=68
MTEX 3.3.1 - 07/2012
bugfix release
- fix: single/double convention get sometimes wrong with tensors
- fix: tensor checks did not respect rounding errors
- fix: ingorePhase default is now none
- fix: calcAngleDistribution works with ODF option
- fix: respect rounding errors when importing pole figures and ODFs
MTEX 3.3.0 - 06/2012
Grains: change of internal representation
Reimplementation of the whole grain part:
- the grain selector tool for spatial grain plots was removed, nevertheless, grains still can be selected spatially.
- scripts using the old grain engine may not work properly, for more details of the functionalities and functioning of the @GrainSet please see the documentation.
- new functionalities: merge grains with certain boundary.
EBSD
The behavior of the 'ignorePhase'
changed. Now it is called in general 'not indexed'
and the not indexed data is imported generally. If the crystal symmetry of an EBSD phase is set to a string value, it will be treated as not indexed. e.g. mark the first phase as 'not indexed'
By default, calcGrains
does also use the 'not Indexed'
phase.
- create customized orientation colormaps
Other
- the comand
set_mtex_option
is obsolete. Use the matlab commandsetMTEXpref(...)
instead. Additionally, one can now see all options by the commandgetpref('mtex')
MTEX 3.2.3 - 03/2012
bugfix release
- allow zooming for multiplot objects again; change the z-order of axes
- symmetries allows now options a | | x additional to x | | a
- fix http://code.google.com/p/mtex/issues/detail?id=35
- fix http://code.google.com/p/mtex/issues/detail?id=38
- fix http://code.google.com/p/mtex/issues/detail?id=28
- fix export odf
MTEX 3.2.1 - 11/2011
New Features
- Import and Export to VPSC
- export EBSD data with all properties
- improved ODF calculation from pole figures by using quadrature weights for the pole figure grid
- implemented spherical Voronoi decomposition and computation of spherical quadrature weights
- plot odf-space in omega-sections, the i.e. generalization of sigma-sections
Bug Fixes
- S2Grid behaves more like vector3d
- vector3d/eq takes antipodal symmetry into account
- Euler angle conversion was sometimes wrong
- tensors multiplication was sometimes wrong
- rank 3 tensors get options 'doubleConvention' and 'singleConvention' for the conversion into the Voigt matrix representation
- documentation fixes
- Miller('[100]') gives not the correct result
- import wizard now generates correct CS definition
- import filter for uxd files should now work more reliable
MTEX 3.2 - 05/2011
3d EBSD Analysis
This release for the first time supports 3d EBSD data. In particular, MTEX is now able to
- import 3d EBSD data from stacked files
- visualize 3d EBSD data by plotting interactive slices through the specimen
- 3d grain detection
- the topology of 3d grains, i.e. boundaries, neighboring grains, etc.
Misorientation Analysis
- computation of the uncorrelated misorientation distribution (MDF) for one or two ODFs
- computation of the theoretical angle distribution of an ODF or MDF
- computation of the misorientation to mean for EBSD data
New Syntax for EBSD and grain variables
EBSD and grain variables can now be indexed by phase, region or grain / ebsd variables. Let us assume we have a two phase ebsd variable containing 'Fe' and 'Mg' then can restrict our dataset to the Fe - phase only by writing
ebsd('Fe')
The same works with grains and also with more than one phase. Please have a look into the documentation for information how to index ebsd and grain variables.
Accordingly the following syntax is now depreciated.
calcODF(ebsd,'phase',2)
It should be replaced by
calcODF(ebsd('Fe'))
Other Enhangments
- better import and export of pole figures, odfs and EBSD data
- automatic centering of a specimen with respect to its specimen symmetry
- download and import tensors from http://www.materialproperties.org/
- new interfaces for Rigaku, Siemens, Bruker and many other X-ray devices and formats
- support for rank three tensors, i.e, for piezo electricity tensors
- improved documentation
- many bug fixes
MTEX 3.1 - 03/2011
Tensor Arithmetics This release introduces tensor analysis into MTEX, this includes
- import of tensors via the import wizard
- basic tensor operations: multiplication, rotation, inversion
- advanced visualization
- computation of averaged tensors from EBSD data and ODFs
- computation of standard elasticity tensors like: Youngs modulus, linear compressibility, Christoffel tensor, elastic wave velocities
Other Enhancements
- support for different crystal reference frame conventions
- automatic conversion between different reference frames
- definition of crystal directions in direct and reciprocal space
- more predefines orientations: Cube, CubeND22, CubeND45, CubeRD, Goss, Copper, SR, Brass, PLage, QLage, ...
- improved EBSD and grain plots
- new and improved interfaces
- many bug fixes
MTEX 3.0 - 10/2010
Crystal Geometry
This release contains a completely redesigned crystal geometry engine which is thought to be much more intuitive and flexible. In particular, it introduces two new classes rotation and orientation which make it much easier to work with crystal orientations. Resulting features are
- no more need for quaternions
- support for Bunge, Roe, Matthies, Kocks, and Canova Euler angle convention
- a simple definition of fibres
- simply check whether two orientations are symmetrically equivalent
Other Enhancements
- automatic kernel selection in ODF estimation from EBSD data
- support for Bingham model ODFs
- estimation of Bingham parameters from EBSD data
- faster and more accurate EBSD simulation
- faster grain reconstruction
- improved documentation
- improved output
- MTEX is now compatible with NFFT 3.1.3
MTEX 2.0 - 10/2009
Grain Analysis for EBSD Data
MTEX is now able to partition spatial EBSD data into grains. This allows for the computation of various grain characteristics, as well as the computation and visualization of the grain boundaries and neighborhood relationships. Main features are:
- Grains statistics (area, diameter, mean orientation, ...)
- Missorientation analysis
- Interactive selection of grains by various criteria
- ODF-calculations for any subset of grains
- A large palette of plotting possibilities.
Visualization Improvements
- ODF fibre plot
- support for different x-axis alignment - plotx2north, plotx2east
- plot EBSD data with respect to arbitrary properties
- plot zero regions of ODFs and pole figures white
- pole figure contour plots
- color triangle for spatial EBSD plots
General Improvements
- ODF import / export
- rotate EBSD data
- Pole figure normalization
- improved interfaces and import wizard
- speed improvement of several side-functions as well as core-functions of @quaternions and spherical grids.
Incompatible Changes to Previous Versions
- The flags reduced and axial have been replaced by the flag antipodal
MTEX 1.2 - 05/2009
Improved EBSD import
- import-weighted EBSD (e.g. from odf modeling)
- new HKL and Chanel interfaces (.ang and .ctf files)
- import of multiple phases
- import of arbitrary properties as MAD, detection error, etc.
Improved EBSD plotting
- plot EBSD data in axis angle and Rodrigues space
- annotations in these spaces
- plot arbitrary properties as MAD, detection error, etc.
- better orientation colorcoding
- superpose odf, pole figure and EBSD plots
- better interpolation
General Improvements
- support for different crystal geometry setups
- faster and more accurate volume computation
- improved function modalorientation
- improved documentation
Incompatible Changes to Previous Versions
- The flag reduced has been replaced by the flag axial
MTEX 1.1 - 12/2008
Improved Import Wizzard
- Load CIF files to specify crystal geometry
- Import EBSD data with coordinates
- More options to specify the alignment of the specimen coordinate system
- support for popla *.epf files, *.plf files, and *.nja files
Improved Pole Figure Analysis
- Background correction and defocusing
- Outlier detection and elimination
Improved EBSD Data Support
- Spatial plot of EBSD data
- Modify EBSD data in the same way as pole figures
Improved Plotting
- GUI to modify plots more easily
- Annotate orientations into pole figure plots
- Annotate orientations into ODF sections
- Coordinate systems for ODF and pole figure plots
- More flexible and consistent option system
- Default plotting options like FontSize, Margin, ...
- Speed improvements
Bug Fixes
- ModalOrientation works now much better
- Plot (0,0) coordinate in ODF plot at upper left
- Fixed a bug in ODF estimation from EBSD data
MTEX 1.0 - 06/2008
New Installer Including Binaries for Windows, Linux, and Max OSX
- MTEX ships now with an automated installer and binaries for Windows, Linux, and Mac OSX. This makes it in unnecessary to install any additional library and to compile the toolbox. (Thanks to F. Bachmann, C. Randau, and F. Wobbe)
New ODF Class
- The new function
FourierODF
provides an easy way to define ODFs via their Fourier coefficients. In particular, MTEX allows now to calculate with those ODFs in the same manner as with any other ODFs.
New Interfaces
- New PoleFigure interface for xrdml data (F. Bachmann)
Improved Plotting
- Plot EBSD data and continuous ODFs into one plot
- Miller indices and specimen directions can now be plotted directly into pole figures or inverse pole figures.
- New plotting option north, south for spherical plots
- Improved colorbar handling
- Spherical grids
- More spherical projections
Incompatible Changes With Previous Releases
- The flag hemisphere in S2Grid has been replaced by north, south, and antipodal making it more consistent with the plotting routine.
Improved Documentation
MTEX comes now with over 500 help pages explaining the mathematical concepts, the philosophy behind MTEX and the syntax and usage of all 300 functions available in MTEX. Furthermore, you find numerous examples and tutorials on ODF estimation, data import, calculation of texture characteristics, ODF and pole figure plotting, etc.
Bug Fixes
- Fixed zero range method
- Fixed automatic ghost correction
- Fixed some loadPoleFigure issues
- Many other bug fixes.
MTEX 0.4 - 04/2008
Speed Improvements
- ODF reconstruction and PDF calculation are about 10 times faster now (thanks to the new NFFT 4.0 library)
- ODF plotting and the calculation of volume fractions, the texture index, the
entropy
and Fourier coefficients is about 100 times faster
New Support of EBSD Data Analysis
- Import EBSD data from arbitrary data formats.
- New class EBSD to store and manipulate with EBSD data.
- Plot pole figures and inverse pole figures from EBSD data.
- Recover ODFs from EBSD data via kernel density estimation.
- Estimate Fourier coefficients from EBSD data.
- Simulate EBSD data from ODFs.
- Export EBSD data.
New Functions
-
fibreVolume
calculates the volume fraction within a fibre. -
plotSpektra
plots the Fourier coefficients of an ODF. -
setcolorrange
and the plotting option colorrange allow for consistent color coding for arbitrary plots. - A colorbar can be added to any plots.
-
mat2quat
andquat2mat
convert rotation matrices to quaternions and vice versa.
Incompatible Changes With Previous Releases
- New, more flexible syntax for the generation of S2Grids
- Slightly changed the syntax of
unimodalODF
andfibreODF
. - Default plotting options are set to {}, i.e. 'antipodal' has to add manually if desired
- Crystal symmetry triclinic is not called tricline anymore.
MTEX 0.3 - 10/2007
- new function
fourier
to calculate the Fourier coefficents of an arbitrary ODF - new option
ghost correction
in function calcODF - new option
zero range
in function calcODF - new function loadEBSD to import EBSD data
- simplified syntax for the import of diffraction data
- new import wizard for pole figure data
- support of triclinic crystal symmetry with arbitrary angles between the axes
- default plotting options may now be specified in mtex_settings.m
- new plot option 3d for a three-dimensional spherical plot of pole figures
- contour levels may be specified explicitly in all plot functions plotodf, plotpdf and plotipdf
- new plot option logarithmic
- many bugfixes
MTEX 0.2 - 07/2007
- new functions texture index, entropy, volume
- greatly improved help
- improved installation
- new options for plotting routines for specific ODF sections
- many bugfixes
MTEX 0.1 - 03/2007
- initial release