manpagez: man pages & more
info gmsh
Home | html | info | man
[ << ] [ < ] [ Up ] [ > ] [ >> ]         [Top] [Contents] [Index] [ ? ]

8.2 Post-processing plugins

Post-processing plugins permit to extend the functionality of Gmsh’s post-processing module. The difference between regular post-processing options (see section Post-processing options list) and post-processing plugins is that regular post-processing options only change the way the data is displayed, while post-processing plugins either create new post-processing views, or modify the data stored in a view (in a destructive, non-reversible way).

Plugins are available in the GUI by right-clicking on a view button (or by clicking on the black arrow next to the view button) and then selecting the ‘Plugin’ submenu.

Here is the list of the plugins that are shipped by default with Gmsh:

Plugin(AnalyseCurvedMesh)

Plugin(AnalyseCurvedMesh) check the jacobian of all elements of dimension ’Dim’ or the greater model dimension if ’Dim’ is either <0 or >3.

Analysis : 0 do nothing +1 find invalid elements (*) +2 compute J_min and J_max of all elements and print some statistics

Effect (for *) : 0 do nothing +1 print a list of invalid elements +2 print some statistics +4 hide valid elements (for GUI)

MaxDepth = 0,1,... 0 : only sample the jacobian 1 : compute Bezier coefficients 2+ : execute a maximum of 1+ subdivision(s)

JacBreak = [0,1[ : if a value of the jacobian <= ’JacBreak’ is found, the element is said to be invalid

BezBreak = [0,JacBreak[ : if all Bezier coefficients are > ’BezBreak’, the element is said to be valid

Tolerance = R+ , << 1 : tolerance (relatively to J_min and J_max) used during the computation of J_min and J_max Numeric options:

Dim

Default value: -1

Analysis

Default value: 2

Effect (1)

Default value: 6

JacBreak (1)

Default value: 0

BezBreak (1)

Default value: 0

MaxDepth (1,2)

Default value: 20

Tolerance (2)

Default value: 0.001

Plugin(Annotate)

Plugin(Annotate) adds the text string ‘Text’, in font ‘Font’ and size ‘FontSize’, in the view ‘View’. The string is aligned according to ‘Align’.

If ‘ThreeD’ is equal to 1, the plugin inserts the string in model coordinates at the position (‘X’,‘Y’,‘Z’). If ‘ThreeD’ is equal to 0, the plugin inserts the string in screen coordinates at the position (‘X’,‘Y’).

If ‘View’ < 0, the plugin is run on the current view.

Plugin(Annotate) is executed in-place for list-based datasets or creates a new view for other datasets. String options:

Text

Default value: "My Text"

Font

Default value: "Helvetica"

Align

Default value: "Left"

Numeric options:

X

Default value: 50

Y

Default value: 30

Z

Default value: 0

ThreeD

Default value: 0

FontSize

Default value: 14

View

Default value: -1

Plugin(Bubbles)

Plugin(Bubbles) constructs a geometry consisting of ‘bubbles’ inscribed in the Voronoi of an input triangulation. ‘ShrinkFactor’ allows to change the size of the bubbles. The plugin expects a triangulation in the ‘z = 0’ plane to exist in the current model.

Plugin(Bubbles) creates one ‘.geo’ file. String options:

OutputFile

Default value: "bubbles.geo"

Numeric options:

ShrinkFactor

Default value: 0

Plugin(Curl)

Plugin(Curl) computes the curl of the field in the view ‘View’.

If ‘View’ < 0, the plugin is run on the current view.

Plugin(Curl) creates one new view. Numeric options:

View

Default value: -1

Plugin(CutBox)

Plugin(CutBox) cuts the view ‘View’ with a rectangular box defined by the 4 points (‘X0’,‘Y0’,‘Z0’) (origin), (‘X1’,‘Y1’,‘Z1’) (axis of U), (‘X2’,‘Y2’,‘Z2’) (axis of V) and (‘X3’,‘Y3’,‘Z3’) (axis of W).

The number of points along U, V, W is set with the options ‘NumPointsU’, ‘NumPointsV’ and ‘NumPointsW’.

If ‘ConnectPoints’ is zero, the plugin creates points; otherwise, the plugin generates hexahedra, quadrangles, lines or points depending on the values of ‘NumPointsU’, ‘NumPointsV’ and ‘NumPointsW’.

If ‘Boundary’ is zero, the plugin interpolates the view inside the box; otherwise the plugin interpolates the view at its boundary.

If ‘View’ < 0, the plugin is run on the current view.

Plugin(CutBox) creates one new view. Numeric options:

X0

Default value: 0

Y0

Default value: 0

Z0

Default value: 0

X1

Default value: 1

Y1

Default value: 0

Z1

Default value: 0

X2

Default value: 0

Y2

Default value: 1

Z2

Default value: 0

X3

Default value: 0

Y3

Default value: 0

Z3

Default value: 1

NumPointsU

Default value: 20

NumPointsV

Default value: 20

NumPointsW

Default value: 20

ConnectPoints

Default value: 1

Boundary

Default value: 1

View

Default value: -1

Plugin(CutGrid)

Plugin(CutGrid) cuts the view ‘View’ with a rectangular grid defined by the 3 points (‘X0’,‘Y0’,‘Z0’) (origin), (‘X1’,‘Y1’,‘Z1’) (axis of U) and (‘X2’,‘Y2’,‘Z2’) (axis of V).

The number of points along U and V is set with the options ‘NumPointsU’ and ‘NumPointsV’.

If ‘ConnectPoints’ is zero, the plugin creates points; otherwise, the plugin generates quadrangles, lines or points depending on the values of ‘NumPointsU’ and ‘NumPointsV’.

If ‘View’ < 0, the plugin is run on the current view.

Plugin(CutGrid) creates one new view. Numeric options:

X0

Default value: 0

Y0

Default value: 0

Z0

Default value: 0

X1

Default value: 1

Y1

Default value: 0

Z1

Default value: 0

X2

Default value: 0

Y2

Default value: 1

Z2

Default value: 0

NumPointsU

Default value: 20

NumPointsV

Default value: 20

ConnectPoints

Default value: 1

View

Default value: -1

Plugin(CutParametric)

Plugin(CutParametric) cuts the view ‘View’ with the parametric function (‘X’(u), ‘Y’(u), ‘Z’(u)), using ‘NumPointsU’ values of the parameter u in [‘MinU’, ‘MaxU’].

If ‘ConnectPoints’ is set, the plugin creates line elements; otherwise, the plugin generates points.

If ‘View’ < 0, the plugin is run on the current view.

Plugin(CutParametric) creates one new view. String options:

X

Default value: "0.1 + 0.5 * Cos(u)"

Y

Default value: "0.1 + 0.5 * Sin(u)"

Z

Default value: "0"

Numeric options:

MinU

Default value: 0

MaxU

Default value: 6.2832

NumPointsU

Default value: 360

ConnectPoints

Default value: 0

View

Default value: -1

Plugin(CutPlane)

Plugin(CutPlane) cuts the view ‘View’ with the plane ‘A’*X + ‘B’*Y + ‘C’*Z + ‘D’ = 0.

If ‘ExtractVolume’ is nonzero, the plugin extracts the elements on one side of the plane (depending on the sign of ‘ExtractVolume’).

If ‘View’ < 0, the plugin is run on the current view.

Plugin(CutPlane) creates one new view. Numeric options:

A

Default value: 1

B

Default value: 0

C

Default value: 0

D

Default value: -0.01

ExtractVolume

Default value: 0

RecurLevel

Default value: 4

TargetError

Default value: 0

View

Default value: -1

Plugin(CutSphere)

Plugin(CutSphere) cuts the view ‘View’ with the sphere (X-‘Xc’)^2 + (Y-‘Yc’)^2 + (Z-‘Zc’)^2 = ‘R’^2.

If ‘ExtractVolume’ is nonzero, the plugin extracts the elements inside (if ‘ExtractVolume’ < 0) or outside (if ‘ExtractVolume’ > 0) the sphere.

If ‘View’ < 0, the plugin is run on the current view.

Plugin(CutSphere) creates one new view. Numeric options:

Xc

Default value: 0

Yc

Default value: 0

Zc

Default value: 0

R

Default value: 0.25

ExtractVolume

Default value: 0

RecurLevel

Default value: 4

TargetError

Default value: 0

View

Default value: -1

Plugin(DiscretizationError)

Plugin(DiscretizationError) computes the error between the mesh and the geometry. It does so by supersampling the elements and computing the distance between the supersampled points dans their projection on the geometry. Numeric options:

SuperSamplingNodes

Default value: 10

Plugin(Distance)

Plugin(Distance) computes distances to physical entities in a mesh.

Define the physical entities to which the distance is computed. If Point=0, Line=0, and Surface=0, then the distance is computed to all the boundaries of the mesh (edges in 2D and faces in 3D).

Computation<0. computes the geometrical euclidian distance (warning: different than the geodesic distance), and Computation=a>0.0 solves a PDE on the mesh with the diffusion constant mu = a*bbox, with bbox being the max size of the bounding box of the mesh (see paper Legrand 2006).

Min Scale and max Scale, scale the distance function. If min Scale<0 and max Scale<0, then no scaling is applied to the distance function.

Plugin(Distance) creates a new distance view and also saves the view in the fileName.pos file. String options:

Filename

Default value: "distance.pos"

Numeric options:

PhysPoint

Default value: 0

PhysLine

Default value: 0

PhysSurface

Default value: 0

Computation

Default value: -1

MinScale

Default value: -1

MaxScale

Default value: -1

Orthogonal

Default value: -1

Plugin(Divergence)

Plugin(Divergence) computes the divergence of the field in the view ‘View’.

If ‘View’ < 0, the plugin is run on the current view.

Plugin(Divergence) creates one new view. Numeric options:

View

Default value: -1

Plugin(Eigenvalues)

Plugin(Eigenvalues) computes the three real eigenvalues of each tensor in the view ‘View’.

If ‘View’ < 0, the plugin is run on the current view.

Plugin(Eigenvalues) creates three new scalar views. Numeric options:

View

Default value: -1

Plugin(Eigenvectors)

Plugin(Eigenvectors) computes the three (right) eigenvectors of each tensor in the view ‘View’ and sorts them according to the value of the associated eigenvalues.

If ‘ScaleByEigenvalues’ is set, each eigenvector is scaled by its associated eigenvalue. The plugin gives an error if the eigenvectors are complex.

If ‘View’ < 0, the plugin is run on the current view.

Plugin(Eigenvectors) creates three new vector view. Numeric options:

ScaleByEigenvalues

Default value: 1

View

Default value: -1

Plugin(ExtractEdges)

Plugin(ExtractEdges) extracts sharp edges from a triangular mesh.

Plugin(ExtractEdges) creates one new view. Numeric options:

Angle

Default value: 40

IncludeBoundary

Default value: 1

Plugin(ExtractElements)

Plugin(ExtractElements) extracts some elements from the view ‘View’. If ‘MinVal’ != ‘MaxVal’, it extracts the elements whose ‘TimeStep’-th values (averaged by element) are comprised between ‘MinVal’ and ‘MaxVal’. If ‘Visible’ != 0, it extracts visible elements.

If ‘View’ < 0, the plugin is run on the current view.

Plugin(ExtractElements) creates one new view. Numeric options:

MinVal

Default value: 0

MaxVal

Default value: 0

TimeStep

Default value: 0

Visible

Default value: 1

View

Default value: -1

Plugin(FieldFromAmplitudePhase)

Plugin(FieldFromAmplitudePhase) builds a complex field ’u’ from amplitude ’a’ (complex) and phase ’phi’ given in two different ’Views’ u = a * exp(k*phi), with k the wavenumber.

The result is to be interpolated in a sufficiently fine mesh: ’MeshFile’.

Plugin(FieldFromAmplitudePhase) generates one new view. String options:

MeshFile

Default value: "fine.msh"

Numeric options:

Wavenumber

Default value: 5

AmplitudeView

Default value: 0

PhaseView

Default value: 1

Plugin(GSHHS)

Plugin(GSHHS) read different kind of contour lines data and write a .geo file on the surface of a sphere (the Earth).

The principal application is to load GSHHS data (see http://www.soest.hawaii.edu/wessel/gshhs/gshhs.html).

Valid values for "Format" are:

- "gshhs": open GSHHS file

- "loops2": import 2D contour lines in simple text format:

NB_POINTS_IN_FIRST_LOOP FIRST_LOOP_IS_CLOSED COORD1 COORD2 COORD1 COORD2 ... ... NB_POINTS_IN_SECOND_LOOP SECOND_LOOP_IS_CLOSED ...

(LOOP_IS_CLOSED specifies if this coast line describes a closed curve (0=no, 1=yes)).

In the case of "loops2" format, you can specify the coordinate system used in the input file with the "Coordinate" option. Valid values are

- "lonlat" for longitude-latidute radian,

- "lonlat_degrees" for longitude-latitude degrees,

- "UTM" for universal transverse mercartor ("UTMZone" option should be specified)

- "cartesian" for full 3D coordinates

- "radius" specify the earth radius.

If the "iField" option is set, consecutive points closer than the value of the field iField (in meters) will not be added.

If "MinStraitsFactor" > 0 and if a field iField is provided, coastlines closer than MinStraitsFactor * field(IField) are merged and inner corners which form an angle < pi/3 are removed.

The output is always in stereographic coordinates, if the "WritePolarSphere" option is greater than 0, a sphere is added to the geo file.

WARNING: this plugin is still experimental and needs polishing and error-handling. In particular, it will probably crash if an inexistant field id is given or if the input/output cannot be open. String options:

InFileName

Default value: "gshhs_c.b"

OutFileName

Default value: "earth.geo"

Format

Default value: "gshhs"

Coordinate

Default value: "cartesian"

Numeric options:

iField

Default value: -1

UTMZone

Default value: 0

UTMEquatorialRadius

Default value: 6.37814e+06

UTMPolarRadius

Default value: 6.35675e+06

radius

Default value: 6.37101e+06

WritePolarSphere

Default value: 1

MinStraitsFactor

Default value: 1

Plugin(Gradient)

Plugin(Gradient) computes the gradient of the field in the view ‘View’.

If ‘View’ < 0, the plugin is run on the current view.

Plugin(Gradient) creates one new view. Numeric options:

View

Default value: -1

Plugin(HarmonicToTime)

Plugin(HarmonicToTime) takes the values in the time steps ‘RealPart’ and ‘ImaginaryPart’ of the view ‘View’, and creates a new view containing

‘View’[‘RealPart’] * cos(p) - ‘View’[‘ImaginaryPart’] * sin(p)

with p = 2*Pi*k/‘NumSteps’, k = 0, ..., ‘NumSteps’-1.

If ‘View’ < 0, the plugin is run on the current view.

Plugin(HarmonicToTime) creates one new view. Numeric options:

RealPart

Default value: 0

ImaginaryPart

Default value: 1

NumSteps

Default value: 20

View

Default value: -1

Plugin(Homology)

Plugin(Homology) computes ranks and basis elements of (relative) homology and cohomology spaces.

Define physical groups in order to specify the computation domain and the relative subdomain. Otherwise the whole mesh is the domain and the relative subdomain is empty.

Plugin(Homology) creates new views, one for each basis element. The resulting basis chains together with the mesh are saved to the file given. String options:

Filename

Default value: "homology.msh"

Numeric options:

PhysicalGroupForDomain1

Default value: 0

PhysicalGroupForDomain2

Default value: 0

PhysicalGroupForSubdomain1

Default value: 0

PhysicalGroupForSubdomain2

Default value: 0

CompututeHomology

Default value: 1

ComputeCohomology

Default value: 0

Plugin(Integrate)

Plugin(Integrate) integrates scalar fields over all the elements in the view ‘View’, as well as the circulation/flux of vector fields over line/surface elements.

If ‘View’ < 0, the plugin is run on the current view.

Plugin(Integrate) creates one new view. Numeric options:

View

Default value: -1

Plugin(Isosurface)

Plugin(Isosurface) extracts the isosurface of value ‘Value’ from the view ‘View’, and draws the ‘OtherTimeStep’-th step of the view ‘OtherView’ on this isosurface.

If ‘ExtractVolume’ is nonzero, the plugin extracts the isovolume with values greater (if ‘ExtractVolume’ > 0) or smaller (if ‘ExtractVolume’ < 0) than the isosurface ‘Value’.

If ‘OtherTimeStep’ < 0, the plugin uses, for each time step in ‘View’, the corresponding time step in ‘OtherView’. If ‘OtherView’ < 0, the plugin uses ‘View’ as the value source.

If ‘View’ < 0, the plugin is run on the current view.

Plugin(Isosurface) creates as many views as there are time steps in ‘View’. Numeric options:

Value

Default value: 0

ExtractVolume

Default value: 0

RecurLevel

Default value: 4

TargetError

Default value: 0

View

Default value: -1

OtherTimeStep

Default value: -1

OtherView

Default value: -1

Plugin(Lambda2)

Plugin(Lambda2) computes the eigenvalues Lambda(1,2,3) of the tensor (S_ik S_kj + Om_ik Om_kj), where S_ij = 0.5 (ui,j + uj,i) and Om_ij = 0.5 (ui,j - uj,i) are respectively the symmetric and antisymmetric parts of the velocity gradient tensor.

Vortices are well represented by regions where Lambda(2) is negative.

If ‘View’ contains tensor elements, the plugin directly uses the tensors as the values of the velocity gradient tensor; if ‘View’ contains vector elements, the plugin uses them as the velocities from which to derive the velocity gradient tensor.

If ‘View’ < 0, the plugin is run on the current view.

Plugin(Lambda2) creates one new view. Numeric options:

Eigenvalue

Default value: 2

View

Default value: -1

Plugin(LongitudeLatitude)

Plugin(LongituteLatitude) projects the view ‘View’ in longitude-latitude.

If ‘View’ < 0, the plugin is run on the current view.

Plugin(LongituteLatitude) is executed in place. Numeric options:

View

Default value: -1

Plugin(MakeSimplex)

Plugin(MakeSimplex) decomposes all non-simplectic elements (quadrangles, prisms, hexahedra, pyramids) in the view ‘View’ into simplices (triangles, tetrahedra).

If ‘View’ < 0, the plugin is run on the current view.

Plugin(MakeSimplex) is executed in-place. Numeric options:

View

Default value: -1

Plugin(MathEval)

Plugin(MathEval) creates a new view using data from the time step ‘TimeStep’ in the view ‘View’.

If only ‘Expression0’ is given (and ‘Expression1’, ..., ‘Expression8’ are all empty), the plugin creates a scalar view. If ‘Expression0’, ‘Expression1’ and/or ‘Expression2’ are given (and ‘Expression3’, ..., ‘Expression8’ are all empty) the plugin creates a vector view. Otherwise the plugin creates a tensor view.

In addition to the usual mathematical functions (Exp, Log, Sqrt, Sin, Cos, Fabs, etc.) and operators (+, -, *, /, ^), all expressions can contain:

- the symbols v0, v1, v2, ..., vn, which represent the n components in ‘View’;

- the symbols w0, w1, w2, ..., wn, which represent the n components of ‘OtherView’, at time step ‘OtherTimeStep’;

- the symbols x, y and z, which represent the three spatial coordinates.

If ‘TimeStep’ < 0, the plugin extracts data from all the time steps in the view.

If ‘View’ < 0, the plugin is run on the current view.

Plugin(MathEval) creates one new view.If ‘PhysicalRegion’ < 0, the plugin is runon all physical regions.

Plugin(MathEval) creates one new view. String options:

Expression0

Default value: "Sqrt(v0^2+v1^2+v2^2)"

Expression1

Default value: ""

Expression2

Default value: ""

Expression3

Default value: ""

Expression4

Default value: ""

Expression5

Default value: ""

Expression6

Default value: ""

Expression7

Default value: ""

Expression8

Default value: ""

Numeric options:

TimeStep

Default value: -1

View

Default value: -1

OtherTimeStep

Default value: -1

OtherView

Default value: -1

ForceInterpolation

Default value: 0

PhysicalRegion

Default value: -1

Plugin(MinMax)

Plugin(MinMax) computes the min/max of a view.

If ‘View’ < 0, the plugin is run on the current view.

If ‘OverTime’ = 1, calculates the min-max over space AND time

Plugin(MinMax) creates two new views. Numeric options:

View

Default value: -1

OverTime

Default value: 0

Plugin(ModifyComponent)

Plugin(ModifyComponent) sets the ‘Component’-th component of the ‘TimeStep’-th time step in the view ‘View’ to the expression ‘Expression’.

‘Expression’ can contain:

- the usual mathematical functions (Log, Sqrt, Sin, Cos, Fabs, ...) and operators (+, -, *, /, ^);

- the symbols x, y and z, to retrieve the coordinates of the current node;

- the symbols Time and TimeStep, to retrieve the current time and time step values;

- the symbol v, to retrieve the ‘Component’-th component of the field in ‘View’ at the ‘TimeStep’-th time step;

- the symbols v0, v1, v2, ..., v8, to retrieve each component of the field in ‘View’ at the ‘TimeStep’-th time step;

- the symbol w, to retrieve the ‘Component’-th component of the field in ‘OtherView’ at the ‘OtherTimeStep’-th time step. If ‘OtherView’ and ‘View’ are based on different spatial grids, or if their data types are different, ‘OtherView’ is interpolated onto ‘View’;

- the symbols w0, w1, w2, ..., w8, to retrieve each component of the field in ‘OtherView’ at the ‘OtherTimeStep’-th time step.

If ‘TimeStep’ < 0, the plugin automatically loops over all the time steps in ‘View’ and evaluates ‘Expression’ for each one.

If ‘OtherTimeStep’ < 0, the plugin uses ‘TimeStep’ instead.

If ‘Component’ < 0, the plugin automatically ops over all the components in the view and evaluates ‘Expression’ for each one.

If ‘View’ < 0, the plugin is run on the current view.

If ‘OtherView’ < 0, the plugin uses ‘View’ instead.

Plugin(ModifyComponent) is executed in-place. String options:

Expression

Default value: "v0 * Sin(x)"

Numeric options:

Component

Default value: -1

TimeStep

Default value: -1

View

Default value: -1

OtherTimeStep

Default value: -1

OtherView

Default value: -1

ForceInterpolation

Default value: 0

Plugin(ModulusPhase)

Plugin(ModulusPhase) interprets the time steps ‘realPart’ and ‘imaginaryPart’ in the view ‘View’ as the real and imaginary parts of a complex field and replaces them with their corresponding modulus and phase.

If ‘View’ < 0, the plugin is run on the current view.

Plugin(ModulusPhase) is executed in-place. Numeric options:

RealPart

Default value: 0

ImaginaryPart

Default value: 1

View

Default value: -1

Plugin(NearToFarField)

Plugin(NearToFarField) computes the far field pattern from the near electric and magnetic fields on a surface (regular grid) enclosing the radiating device (antenna).

Parameters: the wavenumber, the far field distance (radious) and angular discretisation, i.e. the number of divisions for phi in [0, 2*Pi] and theta in [0, Pi].

If ‘View’ < 0, the plugin is run on the current view.

Plugin(NearToFarField) creates one new view. Numeric options:

Wavenumber

Default value: 1

FarDistance

Default value: 1

NumPointsPhi

Default value: 120

NumPointsTheta

Default value: 60

EView

Default value: 0

HView

Default value: 1

Normalize

Default value: 1

dB

Default value: 1

Plugin(NearestNeighbor)

Plugin(NearestNeighbor) computes the distance from each point in ‘View’ to its nearest neighbor.

If ‘View’ < 0, the plugin is run on the current view.

Plugin(NearestNeighbor) is executed in-place. Numeric options:

View

Default value: -1

Plugin(Particles)

Plugin(Particles) computes the trajectory of particules in the force field given by the ‘TimeStep’-th time step of a vector view ‘View’.

The plugin takes as input a grid defined by the 3 points (‘X0’,‘Y0’,‘Z0’) (origin), (‘X1’,‘Y1’,‘Z1’) (axis of U) and (‘X2’,‘Y2’,‘Z2’) (axis of V).

The number of particles along U and V that are to be transported is set with the options ‘NumPointsU’ and ‘NumPointsV’. The equation

A2 * d^2X(t)/dt^2 + A1 * dX(t)/dt + A0 * X(t) = F

is then solved with the initial conditions X(t=0) chosen as the grid, dX/dt(t=0)=0, and with F interpolated from the vector view.

Time stepping is done using a Newmark scheme with step size ‘DT’ and ‘MaxIter’ maximum number of iterations.

If ‘View’ < 0, the plugin is run on the current view.

Plugin(Particles) creates one new view containing multi-step vector points. Numeric options:

X0

Default value: 0

Y0

Default value: 0

Z0

Default value: 0

X1

Default value: 1

Y1

Default value: 0

Z1

Default value: 0

X2

Default value: 0

Y2

Default value: 1

Z2

Default value: 0

NumPointsU

Default value: 10

NumPointsV

Default value: 1

A2

Default value: 1

A1

Default value: 0

A0

Default value: 0

DT

Default value: 0.1

MaxIter

Default value: 100

TimeStep

Default value: 0

View

Default value: -1

Plugin(Probe)

Plugin(Probe) gets the value of the view ‘View’ at the point (‘X’,‘Y’,‘Z’).

If ‘View’ < 0, the plugin is run on the current view.

Plugin(Probe) creates one new view. Numeric options:

X

Default value: 0

Y

Default value: 0

Z

Default value: 0

View

Default value: -1

Plugin(Remove)

Plugin(Remove) removes the marked items from the view ‘View’.

If ‘View’ < 0, the plugin is run on the current view.

Plugin(Remove) is executed in-place. Numeric options:

Text2D

Default value: 1

Text3D

Default value: 1

Points

Default value: 0

Lines

Default value: 0

Triangles

Default value: 0

Quadrangles

Default value: 0

Tetrahedra

Default value: 0

Hexahedra

Default value: 0

Prisms

Default value: 0

Pyramids

Default value: 0

Scalar

Default value: 1

Vector

Default value: 1

Tensor

Default value: 1

View

Default value: -1

Plugin(Scal2Vec)

Plugin(Scal2Vec) converts the scalar fields of ’View X’, ’View Y’ and/or ’View Z’ into a vectorial field. The new view ’Name NewView’ contains it.

If the value of ’View X’, ’View Y’ or ’View Z’ is -1, the value of the vectorial field in the corresponding direction is 0. String options:

Name NewView

Default value: "NewView"

Numeric options:

View X

Default value: -1

View Y

Default value: -1

View Z

Default value: -1

Plugin(Skin)

Plugin(Skin) extracts the boundary (skin) of the view ‘View’. If ‘Visible’ is set, the plugin only extracts the skin of visible entities.

If ‘View’ < 0, the plugin is run on the current view.

Plugin(Skin) creates one new view. Numeric options:

Visible

Default value: 1

View

Default value: -1

Plugin(Smooth)

Plugin(Smooth) averages the values at the nodes of the view ‘View’.

If ‘View’ < 0, the plugin is run on the current view.

Plugin(Smooth) is executed in-place. Numeric options:

View

Default value: -1

Plugin(SphericalRaise)

Plugin(SphericalRaise) transforms the coordinates of the elements in the view ‘View’ using the values associated with the ‘TimeStep’-th time step.

Instead of elevating the nodes along the X, Y and Z axes as with the View[‘View’].RaiseX, View[‘View’].RaiseY and View[‘View’].RaiseZ options, the raise is applied along the radius of a sphere centered at (‘Xc’, ‘Yc’, ‘Zc’).

To produce a standard radiation pattern, set ‘Offset’ to minus the radius of the sphere the original data lives on.

If ‘View’ < 0, the plugin is run on the current view.

Plugin(SphericalRaise) is executed in-place. Numeric options:

Xc

Default value: 0

Yc

Default value: 0

Zc

Default value: 0

Raise

Default value: 1

Offset

Default value: 0

TimeStep

Default value: 0

View

Default value: -1

Plugin(StreamLines)

Plugin(StreamLines) computes stream lines from the ‘TimeStep’-th time step of a vector view ‘View’ and optionally interpolates the scalar view ‘OtherView’ on the resulting stream lines.

The plugin takes as input a grid defined by the 3 points (‘X0’,‘Y0’,‘Z0’) (origin), (‘X1’,‘Y1’,‘Z1’) (axis of U) and (‘X2’,‘Y2’,‘Z2’) (axis of V).

The number of points along U and V that are to be transported is set with the options ‘NumPointsU’ and ‘NumPointsV’. The equation

dX(t)/dt = V(x,y,z)

is then solved with the initial condition X(t=0) chosen as the grid and with V(x,y,z) interpolated on the vector view.

The time stepping scheme is a RK44 with step size ‘DT’ and ‘MaxIter’ maximum number of iterations.

If ‘TimeStep’ < 0, the plugin tries to compute streamlines of the unsteady flow.

If ‘View’ < 0, the plugin is run on the current view.

Plugin(StreamLines) creates one new view. This view contains multi-step vector points if ‘OtherView’ < 0, or single-step scalar lines if ‘OtherView’ >= 0. Numeric options:

X0

Default value: 0

Y0

Default value: 0

Z0

Default value: 0

X1

Default value: 1

Y1

Default value: 0

Z1

Default value: 0

X2

Default value: 0

Y2

Default value: 1

Z2

Default value: 0

NumPointsU

Default value: 10

NumPointsV

Default value: 1

DT

Default value: 0.1

MaxIter

Default value: 100

TimeStep

Default value: 0

View

Default value: -1

OtherView

Default value: -1

Plugin(Tetrahedralize)

Plugin(Tetrahedralize) tetrahedralizes the points in the view ‘View’.

If ‘View’ < 0, the plugin is run on the current view.

Plugin(Tetrahedralize) creates one new view. Numeric options:

View

Default value: -1

Plugin(Transform)

Plugin(Transform) transforms the homogeneous node coordinates (x,y,z,1) of the elements in the view ‘View’ by the matrix

[‘A11’ ‘A12’ ‘A13’ ‘Tx’] [‘A21’ ‘A22’ ‘A23’ ‘Ty’] [‘A31’ ‘A32’ ‘A33’ ‘Tz’].

If ‘SwapOrientation’ is set, the orientation of the elements is reversed.

If ‘View’ < 0, the plugin is run on the current view.

Plugin(Transform) is executed in-place. Numeric options:

A11

Default value: 1

A12

Default value: 0

A13

Default value: 0

A21

Default value: 0

A22

Default value: 1

A23

Default value: 0

A31

Default value: 0

A32

Default value: 0

A33

Default value: 1

Tx

Default value: 0

Ty

Default value: 0

Tz

Default value: 0

SwapOrientation

Default value: 0

View

Default value: -1

Plugin(Triangulate)

Plugin(Triangulate) triangulates the points in the view ‘View’, assuming that all the points belong to a surface that can be projected one-to-one onto a plane.

If ‘View’ < 0, the plugin is run on the current view.

Plugin(Triangulate) creates one new view. Numeric options:

View

Default value: -1

Plugin(Warp)

Plugin(Warp) transforms the elements in the view ‘View’ by adding to their node coordinates the vector field stored in the ‘TimeStep’-th time step of the view ‘OtherView’, scaled by ‘Factor’.

If ‘View’ < 0, the plugin is run on the current view.

If ‘OtherView’ < 0, the vector field is taken as the field of surface normals multiplied by the ‘TimeStep’ value in ‘View’. (The smoothing of the surface normals is controlled by the ‘SmoothingAngle’ parameter.)

Plugin(Warp) is executed in-place. Numeric options:

Factor

Default value: 1

TimeStep

Default value: 0

SmoothingAngle

Default value: 180

View

Default value: -1

OtherView

Default value: -1


[ << ] [ < ] [ Up ] [ > ] [ >> ]         [Top] [Contents] [Index] [ ? ]

This document was generated on June 20, 2012 using texi2html 5.0.

© manpagez.com 2000-2026
Individual documents may contain additional copyright information.