GLVis
v4.2
Accurate and flexible finite element visualization
|
#include <vssolution.hpp>
Public Member Functions | |
VisualizationSceneSolution () | |
VisualizationSceneSolution (Mesh &m, Vector &s, Vector *normals=NULL) | |
virtual | ~VisualizationSceneSolution () |
virtual std::string | GetHelpString () const |
void | SetGridFunction (GridFunction &u) |
void | NewMeshAndSolution (Mesh *new_m, Vector *new_sol, GridFunction *new_u=NULL) |
virtual void | SetNewScalingFromBox () |
virtual void | FindNewBox (bool prepare) |
virtual void | FindNewValueRange (bool prepare) |
virtual void | FindNewBoxAndValueRange (bool prepare) |
virtual void | FindMeshBox (bool prepare) |
virtual void | ToggleLogscale (bool print) |
virtual void | EventUpdateBackground () |
virtual void | EventUpdateColors () |
virtual void | UpdateLevelLines () |
virtual void | UpdateValueRange (bool prepare) |
void | PrepareWithNormals () |
void | PrepareFlat () |
void | PrepareFlat2 () |
virtual void | PrepareLines () |
void | PrepareLines2 () |
void | PrepareLines3 () |
virtual void | Prepare () |
void | PrepareLevelCurves () |
void | PrepareLevelCurves2 () |
void | PrepareBoundary () |
void | PrepareOrderingCurve () |
void | PrepareOrderingCurve1 (gl3::GlDrawable &buf, bool arrows, bool color) |
void | PrepareNumbering () |
void | PrepareElementNumbering () |
void | PrepareElementNumbering1 () |
void | PrepareElementNumbering2 () |
void | PrepareVertexNumbering () |
void | PrepareVertexNumbering1 () |
void | PrepareVertexNumbering2 () |
void | PrepareEdgeNumbering () |
void | PrepareCP () |
virtual gl3::SceneInfo | GetSceneObjs () |
void | glTF_ExportBoundary (glTF_Builder &bld, glTF_Builder::buffer_id buffer, glTF_Builder::material_id black_mat) |
virtual void | glTF_Export () |
void | ToggleDrawBdr () |
virtual void | ToggleDrawElems () |
void | ToggleDrawMesh () |
void | ToggleDrawOrdering () |
void | ToggleDrawNumberings () |
virtual void | SetShading (int, bool) |
void | ToggleShading () |
void | ToggleDrawCP () |
void | ToggleRefinements () |
void | ToggleRefinementFunction () |
virtual void | SetRefineFactors (int, int) |
virtual void | AutoRefine () |
virtual void | ToggleAttributes (Array< int > &attr_list) |
virtual void | SetDrawMesh (int i) |
virtual int | GetShading () |
virtual int | GetDrawMesh () |
Public Member Functions inherited from VisualizationSceneScalarData | |
VisualizationSceneScalarData () | |
VisualizationSceneScalarData (Mesh &m, Vector &s) | |
virtual | ~VisualizationSceneScalarData () |
void | DoAutoscale (bool prepare) |
void | DoAutoscaleValue (bool prepare) |
void | UpdateBoundingBox () |
void | SetValueRange (double, double) |
void | SetAutoRefineLimits (int max_ref, int max_surf_elem) |
virtual void | PrintState () |
Mesh * | GetMesh () |
void | glTF_ExportBox (glTF_Builder &bld, glTF_Builder::buffer_id buffer, glTF_Builder::material_id black_mat) |
void | glTF_ExportElements (glTF_Builder &bld, glTF_Builder::buffer_id buffer, glTF_Builder::material_id palette_mat, const gl3::GlDrawable &gl_drawable) |
void | glTF_ExportMesh (glTF_Builder &bld, glTF_Builder::buffer_id buffer, glTF_Builder::material_id black_mat, const gl3::GlDrawable &gl_drawable) |
double & | GetMinV () |
double & | GetMaxV () |
void | SetLevelLines (double min, double max, int n, int adj=1) |
void | Arrow (gl3::GlBuilder &builder, double px, double py, double pz, double vx, double vy, double vz, double length, double cone_scale=0.075) |
void | Arrow2 (gl3::GlBuilder &builder, double px, double py, double pz, double vx, double vy, double vz, double length, double cone_scale=0.075) |
void | Arrow3 (gl3::GlBuilder &builder, double px, double py, double pz, double vx, double vy, double vz, double length, double cone_scale=0.075) |
void | DrawPolygonLevelLines (gl3::GlBuilder &builder, double *point, int n, Array< double > &level, bool log_vals) |
void | ToggleLight () |
void | SetLight (bool light_set) |
void | ToggleDrawColorbar () |
void | PrepareCaption () |
void | PrepareColorBar (double minval, double maxval, Array< double > *level=NULL, Array< double > *levels=NULL) |
void | SetAxisLabels (const char *a_x, const char *a_y, const char *a_z) |
void | PrepareAxes () |
void | ToggleDrawAxes () |
void | ToggleScaling () |
void | ToggleRuler () |
void | RulerPosition () |
virtual void | PrepareRuler () |
void | PrepareRuler (bool log_z) |
void | ToggleTexture () |
void | Toggle2DView () |
void | SetAutoscale (int _autoscale) |
int | GetAutoscale () const |
void | ShrinkPoints (DenseMatrix &pointmat, int i, int fn, int di) |
Shrink the set of points towards attributes centers of gravity. More... | |
void | ComputeBdrAttrCenter () |
Compute the center of gravity for each boundary attribute. More... | |
void | ComputeElemAttrCenter () |
Compute the center of gravity for each element attribute. More... | |
Public Member Functions inherited from VisualizationScene | |
VisualizationScene () | |
virtual | ~VisualizationScene () |
void | SetView (double theta, double phi) |
void | Zoom (double factor) |
void | Rotate (double angle, double x, double y, double z) |
void | PreRotate (double angle, double x, double y, double z) |
void | Rotate (double angley, double anglex) |
void | Translate (double x, double y, double z=0.0) |
void | Scale (double s) |
void | Scale (double s1, double s2, double s3) |
void | CenterObject () |
void | CenterObject2D () |
void | SetProjectionMtx (glm::mat4 projection) |
void | SetLightMatIdx (unsigned i) |
int | GetLightMatIdx () |
void | SetLight0CustomPos (std::array< float, 4 > pos) |
void | ToggleBackground () |
void | GenerateAlphaTexture () |
Public Attributes | |
int | shading |
int | attr_to_show |
int | bdr_attr_to_show |
Array< int > | el_attr_to_show |
Array< int > | bdr_el_attr_to_show |
Public Attributes inherited from VisualizationSceneScalarData | |
Plane * | CuttingPlane |
int | key_r_state |
double | shrink |
double | shrinkmat |
Shrink factor with respect to the element (material) attributes centers. More... | |
DenseMatrix | bdrc |
DenseMatrix | matc |
Public Attributes inherited from VisualizationScene | |
int | spinning |
int | OrthogonalProjection |
int | |
int | movie |
double | ViewAngle |
double | ViewScale |
double | ViewCenterX |
double | ViewCenterY |
Camera | cam |
PaletteState | palette |
struct { | |
double x [2] | |
double y [2] | |
double z [2] | |
} | bb |
Bounding box. More... | |
double | cut_lambda |
Amount of face cutting with keys Ctrl-F3/F4 (0: no cut, 1: cut to edges) More... | |
bool | cut_updated |
Have the reference geometries been updated for the cut? More... | |
glm::mat4 | rotmat |
glm::mat4 | translmat |
float | matAlpha = 1.0 |
float | matAlphaCenter = 0.5 |
int | view |
This is set by SetVisualizationScene. More... | |
Protected Member Functions | |
void | Init () |
void | FindNewBox (double rx[], double ry[], double rval[]) |
void | DrawCPLine (gl3::GlBuilder &bld, DenseMatrix &pointmat, Vector &values, Array< int > &ind) |
void | GetRefinedDetJ (int i, const IntegrationRule &ir, Vector &vals, DenseMatrix &tr) |
virtual void | GetRefinedValues (int i, const IntegrationRule &ir, Vector &vals, DenseMatrix &tr) |
virtual int | GetRefinedValuesAndNormals (int i, const IntegrationRule &ir, Vector &vals, DenseMatrix &tr, DenseMatrix &normals) |
void | DrawLevelCurves (gl3::GlBuilder &buf, Array< int > &RG, DenseMatrix &pointmat, Vector &values, int sides, Array< double > &lvl, int flat=0) |
int | GetAutoRefineFactor () |
double | GetElementLengthScale (int k) |
Protected Member Functions inherited from VisualizationSceneScalarData | |
void | Init () |
bool | LogscaleRange () |
void | PrintLogscale (bool warn) |
void | SetLogA () |
double | _ULogVal (const double &u) |
double | ULogVal (const double &u) |
double | LogUVal (const double &z) |
double | _LogVal_ (const double &z) |
double | _LogVal (const double &z) |
double | LogVal (const double &z, const bool &log_val) |
double | LogVal (const double &z) |
void | FixValueRange () |
void | Cone (gl3::GlBuilder &builder, glm::mat4 transform) |
Protected Member Functions inherited from VisualizationScene | |
gl3::RenderParams | GetMeshDrawParams () |
glm::mat4 | GetModelViewMtx () |
std::array< float, 4 > | GetLineColor () |
void | MySetColor (gl3::GlBuilder &builder, double val, double min, double max) |
void | MySetColor (gl3::GlBuilder &builder, double val) |
void | DrawTriangle (gl3::GlDrawable &buff, const double(&pts)[4][3], const double(&cv)[4], const double minv, const double maxv) |
void | DrawQuad (gl3::GlDrawable &buff, const double(&pts)[4][3], const double(&cv)[4], const double minv, const double maxv) |
void | DrawCutTriangle (gl3::GlDrawable &buff, const double(&pts)[4][3], const double(&cv)[4], const double minv, const double maxv) |
void | DrawCutQuad (gl3::GlDrawable &buff, const double(&pts)[4][3], const double(&cv)[4], const double minv, const double maxv) |
void | DrawPatch (gl3::GlDrawable &buff, const mfem::DenseMatrix &pts, mfem::Vector &vals, mfem::DenseMatrix &normals, const int n, const mfem::Array< int > &ind, const double minv, const double maxv, const int normals_opt=0) |
glTF_Builder::material_id | AddPaletteMaterial (glTF_Builder &bld) |
glTF_Builder::material_id | AddBlackMaterial (glTF_Builder &bld) |
glTF_Builder::material_id | AddPaletteLinesMaterial (glTF_Builder &bld, glTF_Builder::material_id palette_mat) |
glTF_Builder::node_id | AddModelNode (glTF_Builder &bld, const std::string &nodeName) |
int | AddTriangles (glTF_Builder &bld, glTF_Builder::mesh_id mesh, glTF_Builder::buffer_id buffer, glTF_Builder::material_id material, const gl3::GlDrawable &gl_drawable) |
int | AddLines (glTF_Builder &bld, glTF_Builder::mesh_id mesh, glTF_Builder::buffer_id buffer, glTF_Builder::material_id material, const gl3::GlDrawable &gl_drawable) |
Additional Inherited Members | |
Protected Types inherited from VisualizationScene | |
enum | { BG_BLK = 0, BG_WHITE = 1 } |
Definition at line 26 of file vssolution.hpp.
VisualizationSceneSolution::VisualizationSceneSolution | ( | ) |
Definition at line 419 of file vssolution.cpp.
VisualizationSceneSolution::VisualizationSceneSolution | ( | Mesh & | m, |
Vector & | s, | ||
Vector * | normals = NULL |
||
) |
Definition at line 424 of file vssolution.cpp.
|
virtual |
Definition at line 519 of file vssolution.cpp.
|
virtual |
Implements VisualizationSceneScalarData.
Definition at line 915 of file vssolution.cpp.
|
protected |
Definition at line 2221 of file vssolution.cpp.
|
protected |
Definition at line 1485 of file vssolution.cpp.
|
virtual |
Reimplemented from VisualizationSceneScalarData.
Definition at line 1107 of file vssolution.cpp.
|
virtual |
Reimplemented from VisualizationSceneScalarData.
Reimplemented in VisualizationSceneVector.
Definition at line 1101 of file vssolution.cpp.
|
virtual |
Reimplemented from VisualizationSceneScalarData.
Definition at line 1066 of file vssolution.cpp.
|
protected |
Definition at line 969 of file vssolution.cpp.
|
virtual |
Implements VisualizationSceneScalarData.
Definition at line 1037 of file vssolution.cpp.
|
inlinevirtual |
Reimplemented from VisualizationSceneScalarData.
Definition at line 103 of file vssolution.hpp.
|
virtual |
Implements VisualizationSceneScalarData.
Definition at line 1053 of file vssolution.cpp.
|
protected |
Definition at line 903 of file vssolution.cpp.
|
inlinevirtual |
Definition at line 175 of file vssolution.hpp.
|
protected |
Definition at line 1619 of file vssolution.cpp.
|
virtual |
Reimplemented from VisualizationSceneScalarData.
Reimplemented in VisualizationSceneVector.
Definition at line 51 of file vssolution.cpp.
|
protected |
Definition at line 607 of file vssolution.cpp.
|
protectedvirtual |
Reimplemented in VisualizationSceneVector.
Definition at line 660 of file vssolution.cpp.
|
protectedvirtual |
Reimplemented in VisualizationSceneVector.
Definition at line 684 of file vssolution.cpp.
|
virtual |
Reimplemented from VisualizationSceneScalarData.
Reimplemented in VisualizationSceneVector.
Definition at line 2258 of file vssolution.cpp.
|
inlinevirtual |
Definition at line 174 of file vssolution.hpp.
|
virtual |
Reimplemented from VisualizationSceneScalarData.
Reimplemented in VisualizationSceneVector.
Definition at line 2364 of file vssolution.cpp.
void VisualizationSceneSolution::glTF_ExportBoundary | ( | glTF_Builder & | bld, |
glTF_Builder::buffer_id | buffer, | ||
glTF_Builder::material_id | black_mat | ||
) |
Definition at line 2343 of file vssolution.cpp.
|
protected |
Definition at line 434 of file vssolution.cpp.
void VisualizationSceneSolution::NewMeshAndSolution | ( | Mesh * | new_m, |
Vector * | new_sol, | ||
GridFunction * | new_u = NULL |
||
) |
Definition at line 575 of file vssolution.cpp.
|
virtual |
Implements VisualizationSceneScalarData.
Definition at line 1344 of file vssolution.cpp.
void VisualizationSceneSolution::PrepareBoundary | ( | ) |
Definition at line 2046 of file vssolution.cpp.
void VisualizationSceneSolution::PrepareCP | ( | ) |
Definition at line 2126 of file vssolution.cpp.
void VisualizationSceneSolution::PrepareEdgeNumbering | ( | ) |
Definition at line 1818 of file vssolution.cpp.
void VisualizationSceneSolution::PrepareElementNumbering | ( | ) |
Definition at line 1650 of file vssolution.cpp.
void VisualizationSceneSolution::PrepareElementNumbering1 | ( | ) |
Definition at line 1662 of file vssolution.cpp.
void VisualizationSceneSolution::PrepareElementNumbering2 | ( | ) |
Definition at line 1701 of file vssolution.cpp.
void VisualizationSceneSolution::PrepareFlat | ( | ) |
Definition at line 1201 of file vssolution.cpp.
void VisualizationSceneSolution::PrepareFlat2 | ( | ) |
Definition at line 1242 of file vssolution.cpp.
void VisualizationSceneSolution::PrepareLevelCurves | ( | ) |
Definition at line 1454 of file vssolution.cpp.
void VisualizationSceneSolution::PrepareLevelCurves2 | ( | ) |
Definition at line 1564 of file vssolution.cpp.
|
virtual |
Implements VisualizationSceneScalarData.
Reimplemented in VisualizationSceneVector.
Definition at line 1586 of file vssolution.cpp.
void VisualizationSceneSolution::PrepareLines2 | ( | ) |
Definition at line 1953 of file vssolution.cpp.
void VisualizationSceneSolution::PrepareLines3 | ( | ) |
Definition at line 1988 of file vssolution.cpp.
void VisualizationSceneSolution::PrepareNumbering | ( | ) |
Definition at line 1946 of file vssolution.cpp.
void VisualizationSceneSolution::PrepareOrderingCurve | ( | ) |
Definition at line 1857 of file vssolution.cpp.
void VisualizationSceneSolution::PrepareOrderingCurve1 | ( | gl3::GlDrawable & | buf, |
bool | arrows, | ||
bool | color | ||
) |
Definition at line 1868 of file vssolution.cpp.
void VisualizationSceneSolution::PrepareVertexNumbering | ( | ) |
Definition at line 1732 of file vssolution.cpp.
void VisualizationSceneSolution::PrepareVertexNumbering1 | ( | ) |
Definition at line 1744 of file vssolution.cpp.
void VisualizationSceneSolution::PrepareVertexNumbering2 | ( | ) |
Definition at line 1780 of file vssolution.cpp.
void VisualizationSceneSolution::PrepareWithNormals | ( | ) |
Definition at line 1156 of file vssolution.cpp.
|
inlinevirtual |
Definition at line 173 of file vssolution.hpp.
|
inline |
Definition at line 95 of file vssolution.hpp.
|
virtual |
Reimplemented from VisualizationSceneScalarData.
Definition at line 950 of file vssolution.cpp.
|
virtual |
Implements VisualizationSceneScalarData.
Definition at line 876 of file vssolution.cpp.
|
virtual |
Implements VisualizationSceneScalarData.
Definition at line 743 of file vssolution.cpp.
|
virtual |
Implements VisualizationSceneScalarData.
Definition at line 924 of file vssolution.cpp.
void VisualizationSceneSolution::ToggleDrawBdr | ( | ) |
Definition at line 223 of file vssolution.cpp.
|
inline |
Definition at line 164 of file vssolution.hpp.
|
virtual |
Reimplemented in VisualizationSceneVector.
Definition at line 523 of file vssolution.cpp.
|
inline |
Definition at line 152 of file vssolution.hpp.
|
inline |
Definition at line 159 of file vssolution.hpp.
|
inline |
Definition at line 156 of file vssolution.hpp.
|
virtual |
Reimplemented from VisualizationSceneScalarData.
Definition at line 1075 of file vssolution.cpp.
void VisualizationSceneSolution::ToggleRefinementFunction | ( | ) |
Definition at line 855 of file vssolution.cpp.
void VisualizationSceneSolution::ToggleRefinements | ( | ) |
Definition at line 804 of file vssolution.cpp.
void VisualizationSceneSolution::ToggleShading | ( | ) |
Definition at line 792 of file vssolution.cpp.
|
inlinevirtual |
Implements VisualizationSceneScalarData.
Definition at line 110 of file vssolution.hpp.
|
virtual |
Implements VisualizationSceneScalarData.
Definition at line 2022 of file vssolution.cpp.
int VisualizationSceneSolution::attr_to_show |
Definition at line 85 of file vssolution.hpp.
int VisualizationSceneSolution::bdr_attr_to_show |
Definition at line 85 of file vssolution.hpp.
|
protected |
Definition at line 50 of file vssolution.hpp.
Array<int> VisualizationSceneSolution::bdr_el_attr_to_show |
Definition at line 86 of file vssolution.hpp.
|
protected |
Definition at line 51 of file vssolution.hpp.
|
protected |
Definition at line 42 of file vssolution.hpp.
|
protected |
Definition at line 33 of file vssolution.hpp.
|
protected |
Definition at line 33 of file vssolution.hpp.
|
protected |
Definition at line 32 of file vssolution.hpp.
|
protected |
Definition at line 32 of file vssolution.hpp.
|
protected |
Definition at line 32 of file vssolution.hpp.
|
protected |
Definition at line 32 of file vssolution.hpp.
|
protected |
Definition at line 44 of file vssolution.hpp.
|
protected |
Definition at line 40 of file vssolution.hpp.
Array<int> VisualizationSceneSolution::el_attr_to_show |
Definition at line 86 of file vssolution.hpp.
|
protected |
Definition at line 46 of file vssolution.hpp.
|
protected |
Definition at line 38 of file vssolution.hpp.
|
protected |
Definition at line 48 of file vssolution.hpp.
|
protected |
Definition at line 49 of file vssolution.hpp.
|
protected |
Definition at line 37 of file vssolution.hpp.
|
protected |
Definition at line 37 of file vssolution.hpp.
|
protected |
Definition at line 53 of file vssolution.hpp.
|
protected |
Definition at line 54 of file vssolution.hpp.
|
protected |
Definition at line 35 of file vssolution.hpp.
|
protected |
Definition at line 30 of file vssolution.hpp.
int VisualizationSceneSolution::shading |
Definition at line 83 of file vssolution.hpp.
|
protected |
Definition at line 40 of file vssolution.hpp.
|
protected |
Definition at line 29 of file vssolution.hpp.
|
protected |
Definition at line 45 of file vssolution.hpp.