![]() |
GLVis
v4.2
Accurate and flexible finite element visualization
|
#include <vsdata.hpp>
Public Member Functions | |
| VisualizationSceneScalarData () | |
| VisualizationSceneScalarData (Mesh &m, Vector &s) | |
| virtual | ~VisualizationSceneScalarData () |
| virtual std::string | GetHelpString () const |
| virtual void | SetNewScalingFromBox () |
| virtual void | FindNewBox (bool prepare)=0 |
| virtual void | FindNewValueRange (bool prepare)=0 |
| virtual void | FindNewBoxAndValueRange (bool prepare) |
| virtual void | FindMeshBox (bool prepare) |
| void | DoAutoscale (bool prepare) |
| void | DoAutoscaleValue (bool prepare) |
| virtual void | Prepare ()=0 |
| virtual void | PrepareLines ()=0 |
| void | UpdateBoundingBox () |
| virtual void | EventUpdateBackground () |
| virtual void | EventUpdateColors () |
| virtual void | UpdateLevelLines ()=0 |
| virtual void | UpdateValueRange (bool prepare)=0 |
| void | SetValueRange (double, double) |
| virtual void | SetShading (int, bool)=0 |
| virtual void | SetRefineFactors (int, int)=0 |
| void | SetAutoRefineLimits (int max_ref, int max_surf_elem) |
| virtual void | AutoRefine ()=0 |
| virtual void | ToggleAttributes (Array< int > &attr_list)=0 |
| virtual void | PrintState () |
| Mesh * | GetMesh () |
| virtual gl3::SceneInfo | GetSceneObjs () |
| 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) |
| virtual void | glTF_Export () |
| 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 () |
| virtual void | ToggleLogscale (bool print) |
| 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 | |
| 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 () |
| 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) |
Protected Attributes | |
| Mesh * | mesh |
| Vector * | sol |
| double | minv |
| double | maxv |
| std::string | a_label_x |
| std::string | a_label_y |
| std::string | a_label_z |
| int | scaling |
| int | colorbar |
| int | drawaxes |
| int | auto_ref_max |
| int | auto_ref_max_surf_elem |
| vector< gl3::GlDrawable * > | updated_bufs |
| gl3::GlDrawable | axes_buf |
| gl3::GlDrawable | coord_cross_buf |
| gl3::GlDrawable | color_bar |
| gl3::GlDrawable | ruler_buf |
| gl3::GlDrawable | caption_buf |
| int | caption_w |
| int | caption_h |
| int | arrow_type |
| int | arrow_scaling_type |
| int | nl |
| Array< double > | level |
| int | ruler_on |
| double | ruler_x |
| double | ruler_y |
| double | ruler_z |
| int | autoscale |
| bool | logscale |
| double | log_a |
| double | unit_a |
Protected Attributes inherited from VisualizationScene | |
| double | xscale |
| double | yscale |
| double | zscale |
| SdlWindow * | wnd |
| glm::mat4 | proj_mtx |
| enum VisualizationScene:: { ... } | background |
| const Material | BLK_MAT |
| std::array< float, 4 > | _l0_pos |
| bool | _use_cust_l0_pos |
| int | light_mat_idx |
| bool | use_light |
Additional Inherited Members | |
Protected Types inherited from VisualizationScene | |
| enum | { BG_BLK = 0, BG_WHITE = 1 } |
Definition at line 55 of file vsdata.hpp.
|
inline |
Definition at line 138 of file vsdata.hpp.
| VisualizationSceneScalarData::VisualizationSceneScalarData | ( | Mesh & | m, |
| Vector & | s | ||
| ) |
Definition at line 1150 of file vsdata.cpp.
|
virtual |
Definition at line 1264 of file vsdata.cpp.
|
inlineprotected |
Definition at line 119 of file vsdata.hpp.
|
inlineprotected |
Definition at line 118 of file vsdata.hpp.
|
inlineprotected |
Definition at line 110 of file vsdata.hpp.
| void VisualizationSceneScalarData::Arrow | ( | gl3::GlBuilder & | builder, |
| double | px, | ||
| double | py, | ||
| double | pz, | ||
| double | vx, | ||
| double | vy, | ||
| double | vz, | ||
| double | length, | ||
| double | cone_scale = 0.075 |
||
| ) |
Definition at line 205 of file vsdata.cpp.
| void VisualizationSceneScalarData::Arrow2 | ( | gl3::GlBuilder & | builder, |
| double | px, | ||
| double | py, | ||
| double | pz, | ||
| double | vx, | ||
| double | vy, | ||
| double | vz, | ||
| double | length, | ||
| double | cone_scale = 0.075 |
||
| ) |
Definition at line 172 of file vsdata.cpp.
| void VisualizationSceneScalarData::Arrow3 | ( | gl3::GlBuilder & | builder, |
| double | px, | ||
| double | py, | ||
| double | pz, | ||
| double | vx, | ||
| double | vy, | ||
| double | vz, | ||
| double | length, | ||
| double | cone_scale = 0.075 |
||
| ) |
Definition at line 114 of file vsdata.cpp.
|
pure virtual |
Implemented in VisualizationSceneSolution, and VisualizationSceneSolution3d.
| void VisualizationSceneScalarData::ComputeBdrAttrCenter | ( | ) |
Compute the center of gravity for each boundary attribute.
Definition at line 1612 of file vsdata.cpp.
| void VisualizationSceneScalarData::ComputeElemAttrCenter | ( | ) |
Compute the center of gravity for each element attribute.
Definition at line 1641 of file vsdata.cpp.
|
protected |
Definition at line 76 of file vsdata.cpp.
| void VisualizationSceneScalarData::DoAutoscale | ( | bool | prepare | ) |
Definition at line 48 of file vsdata.cpp.
| void VisualizationSceneScalarData::DoAutoscaleValue | ( | bool | prepare | ) |
Definition at line 64 of file vsdata.cpp.
| void VisualizationSceneScalarData::DrawPolygonLevelLines | ( | gl3::GlBuilder & | builder, |
| double * | point, | ||
| int | n, | ||
| Array< double > & | level, | ||
| bool | log_vals | ||
| ) |
Definition at line 1440 of file vsdata.cpp.
|
inlinevirtual |
Reimplemented in VisualizationSceneSolution.
Definition at line 179 of file vsdata.hpp.
|
inlinevirtual |
Reimplemented in VisualizationSceneSolution3d, VisualizationSceneSolution, VisualizationSceneVector, and VisualizationSceneVector3d.
Definition at line 180 of file vsdata.hpp.
|
inlinevirtual |
Reimplemented in VisualizationSceneSolution.
Definition at line 164 of file vsdata.hpp.
|
pure virtual |
Implemented in VisualizationSceneSolution3d, and VisualizationSceneSolution.
|
inlinevirtual |
Reimplemented in VisualizationSceneSolution.
Definition at line 160 of file vsdata.hpp.
|
pure virtual |
Implemented in VisualizationSceneSolution3d, and VisualizationSceneSolution.
|
protected |
Definition at line 29 of file vsdata.cpp.
|
inline |
Definition at line 282 of file vsdata.hpp.
|
inlinevirtual |
Reimplemented in VisualizationSceneSolution3d, VisualizationSceneSolution, VisualizationSceneVector, and VisualizationSceneVector3d.
Definition at line 144 of file vsdata.hpp.
|
inline |
Definition at line 215 of file vsdata.hpp.
|
inline |
Definition at line 197 of file vsdata.hpp.
|
inline |
Definition at line 214 of file vsdata.hpp.
|
virtual |
Implements VisualizationScene.
Reimplemented in VisualizationSceneSolution, VisualizationSceneSolution3d, VisualizationSceneVector, and VisualizationSceneVector3d.
Definition at line 984 of file vsdata.cpp.
|
virtual |
Reimplemented in VisualizationSceneSolution, VisualizationSceneSolution3d, and VisualizationSceneVector.
Definition at line 1120 of file vsdata.cpp.
| void VisualizationSceneScalarData::glTF_ExportBox | ( | glTF_Builder & | bld, |
| glTF_Builder::buffer_id | buffer, | ||
| glTF_Builder::material_id | black_mat | ||
| ) |
Definition at line 1053 of file vsdata.cpp.
| void VisualizationSceneScalarData::glTF_ExportElements | ( | glTF_Builder & | bld, |
| glTF_Builder::buffer_id | buffer, | ||
| glTF_Builder::material_id | palette_mat, | ||
| const gl3::GlDrawable & | gl_drawable | ||
| ) |
Definition at line 1076 of file vsdata.cpp.
| void VisualizationSceneScalarData::glTF_ExportMesh | ( | glTF_Builder & | bld, |
| glTF_Builder::buffer_id | buffer, | ||
| glTF_Builder::material_id | black_mat, | ||
| const gl3::GlDrawable & | gl_drawable | ||
| ) |
Definition at line 1098 of file vsdata.cpp.
|
protected |
Definition at line 1160 of file vsdata.cpp.
|
inlineprotected |
Definition at line 95 of file vsdata.hpp.
|
inlineprotected |
Definition at line 113 of file vsdata.hpp.
|
inlineprotected |
Definition at line 121 of file vsdata.hpp.
|
inlineprotected |
Definition at line 123 of file vsdata.hpp.
|
pure virtual |
Implemented in VisualizationSceneSolution3d, VisualizationSceneSolution, and VisualizationSceneVector3d.
| void VisualizationSceneScalarData::PrepareAxes | ( | ) |
Definition at line 1323 of file vsdata.cpp.
| void VisualizationSceneScalarData::PrepareCaption | ( | ) |
Definition at line 449 of file vsdata.cpp.
| void VisualizationSceneScalarData::PrepareColorBar | ( | double | minval, |
| double | maxval, | ||
| Array< double > * | level = NULL, |
||
| Array< double > * | levels = NULL |
||
| ) |
Definition at line 333 of file vsdata.cpp.
|
pure virtual |
Implemented in VisualizationSceneSolution3d, VisualizationSceneSolution, VisualizationSceneVector, and VisualizationSceneVector3d.
|
inlinevirtual |
Reimplemented in VisualizationSceneSolution3d.
Definition at line 274 of file vsdata.hpp.
| void VisualizationSceneScalarData::PrepareRuler | ( | bool | log_z | ) |
Definition at line 875 of file vsdata.cpp.
|
protected |
Definition at line 800 of file vsdata.cpp.
|
virtual |
Definition at line 1524 of file vsdata.cpp.
| void VisualizationSceneScalarData::RulerPosition | ( | ) |
Definition at line 839 of file vsdata.cpp.
|
inline |
Definition at line 187 of file vsdata.hpp.
| void VisualizationSceneScalarData::SetAutoscale | ( | int | _autoscale | ) |
Definition at line 1141 of file vsdata.cpp.
| void VisualizationSceneScalarData::SetAxisLabels | ( | const char * | a_x, |
| const char * | a_y, | ||
| const char * | a_z | ||
| ) |
Definition at line 1313 of file vsdata.cpp.
| void VisualizationSceneScalarData::SetLevelLines | ( | double | min, |
| double | max, | ||
| int | n, | ||
| int | adj = 1 |
||
| ) |
Definition at line 1483 of file vsdata.cpp.
|
inline |
Definition at line 238 of file vsdata.hpp.
|
inlineprotected |
Definition at line 99 of file vsdata.hpp.
|
virtual |
Reimplemented in VisualizationSceneSolution.
Definition at line 1269 of file vsdata.cpp.
|
pure virtual |
Implemented in VisualizationSceneSolution, and VisualizationSceneSolution3d.
|
pure virtual |
Implemented in VisualizationSceneSolution, and VisualizationSceneSolution3d.
| void VisualizationSceneScalarData::SetValueRange | ( | double | min, |
| double | max | ||
| ) |
Definition at line 1305 of file vsdata.cpp.
| void VisualizationSceneScalarData::ShrinkPoints | ( | DenseMatrix & | pointmat, |
| int | i, | ||
| int | fn, | ||
| int | di | ||
| ) |
Shrink the set of points towards attributes centers of gravity.
Definition at line 1546 of file vsdata.cpp.
| void VisualizationSceneScalarData::Toggle2DView | ( | ) |
Definition at line 943 of file vsdata.cpp.
|
pure virtual |
Implemented in VisualizationSceneSolution, and VisualizationSceneSolution3d.
|
inline |
Definition at line 258 of file vsdata.hpp.
|
inline |
Definition at line 240 of file vsdata.hpp.
|
inline |
Definition at line 237 of file vsdata.hpp.
|
virtual |
Reimplemented in VisualizationSceneSolution.
Definition at line 811 of file vsdata.cpp.
| void VisualizationSceneScalarData::ToggleRuler | ( | ) |
Definition at line 833 of file vsdata.cpp.
|
inline |
Definition at line 267 of file vsdata.hpp.
| void VisualizationSceneScalarData::ToggleTexture | ( | ) |
Definition at line 1126 of file vsdata.cpp.
|
inlineprotected |
Definition at line 111 of file vsdata.hpp.
|
inline |
Definition at line 178 of file vsdata.hpp.
|
pure virtual |
Implemented in VisualizationSceneSolution3d, and VisualizationSceneSolution.
|
pure virtual |
Implemented in VisualizationSceneSolution3d, and VisualizationSceneSolution.
|
protected |
Definition at line 63 of file vsdata.hpp.
|
protected |
Definition at line 63 of file vsdata.hpp.
|
protected |
Definition at line 63 of file vsdata.hpp.
|
protected |
Definition at line 78 of file vsdata.hpp.
|
protected |
Definition at line 78 of file vsdata.hpp.
|
protected |
Definition at line 66 of file vsdata.hpp.
|
protected |
Definition at line 66 of file vsdata.hpp.
|
protected |
Definition at line 91 of file vsdata.hpp.
|
protected |
Definition at line 69 of file vsdata.hpp.
| DenseMatrix VisualizationSceneScalarData::bdrc |
Definition at line 287 of file vsdata.hpp.
|
protected |
Definition at line 73 of file vsdata.hpp.
|
protected |
Definition at line 74 of file vsdata.hpp.
|
protected |
Definition at line 74 of file vsdata.hpp.
|
protected |
Definition at line 71 of file vsdata.hpp.
|
protected |
Definition at line 65 of file vsdata.hpp.
|
protected |
Definition at line 70 of file vsdata.hpp.
| Plane* VisualizationSceneScalarData::CuttingPlane |
Definition at line 130 of file vsdata.hpp.
|
protected |
Definition at line 65 of file vsdata.hpp.
| int VisualizationSceneScalarData::key_r_state |
Definition at line 131 of file vsdata.hpp.
|
protected |
Definition at line 81 of file vsdata.hpp.
|
protected |
Definition at line 98 of file vsdata.hpp.
|
protected |
Definition at line 93 of file vsdata.hpp.
| DenseMatrix VisualizationSceneScalarData::matc |
Definition at line 287 of file vsdata.hpp.
|
protected |
Definition at line 61 of file vsdata.hpp.
|
protected |
Definition at line 58 of file vsdata.hpp.
|
protected |
Definition at line 61 of file vsdata.hpp.
|
protected |
Definition at line 80 of file vsdata.hpp.
|
protected |
Definition at line 72 of file vsdata.hpp.
|
protected |
Definition at line 83 of file vsdata.hpp.
|
protected |
Definition at line 84 of file vsdata.hpp.
|
protected |
Definition at line 84 of file vsdata.hpp.
|
protected |
Definition at line 84 of file vsdata.hpp.
|
protected |
Definition at line 65 of file vsdata.hpp.
| double VisualizationSceneScalarData::shrink |
Shrink factor with respect to the center of each element (2D) or the center of each boundary attribute (3D)
Definition at line 134 of file vsdata.hpp.
| double VisualizationSceneScalarData::shrinkmat |
Shrink factor with respect to the element (material) attributes centers.
Definition at line 136 of file vsdata.hpp.
|
protected |
Definition at line 59 of file vsdata.hpp.
|
protected |
Definition at line 98 of file vsdata.hpp.
|
protected |
Definition at line 68 of file vsdata.hpp.
1.8.5