![]() |
GLVis
v4.2
Accurate and flexible finite element visualization
|
#include <vssolution3d.hpp>
Public Member Functions | |
| VisualizationSceneSolution3d () | |
| VisualizationSceneSolution3d (Mesh &m, Vector &s) | |
| void | SetGridFunction (GridFunction *gf) |
| void | NewMeshAndSolution (Mesh *new_m, Vector *new_sol, GridFunction *new_u=NULL) |
| virtual | ~VisualizationSceneSolution3d () |
| virtual std::string | GetHelpString () const |
| virtual void | FindNewBox (bool prepare) |
| virtual void | FindNewValueRange (bool prepare) |
| virtual void | PrepareRuler () |
| virtual void | PrepareFlat () |
| virtual void | PrepareLines () |
| virtual void | Prepare () |
| virtual void | PrepareOrderingCurve () |
| virtual void | PrepareOrderingCurve1 (gl3::GlDrawable &buf, bool arrows, bool color) |
| virtual gl3::SceneInfo | GetSceneObjs () |
| virtual void | glTF_Export () |
| void | ToggleDrawElems () |
| void | ToggleDrawMesh () |
| void | ToggleDrawOrdering () |
| void | ToggleShading () |
| int | GetShading () |
| virtual void | SetShading (int, bool) |
| virtual void | SetRefineFactors (int, int) |
| virtual void | AutoRefine () |
| virtual void | ToggleAttributes (Array< int > &attr_list) |
| void | FindNodePos () |
| void | CuttingPlaneFunc (int type) |
| void | CutRefinedElement (gl3::GlDrawable &target, const DenseMatrix &verts, const Vector &vert_dist, const Vector &vals, const Geometry::Type geom, const int *elems, int num_elems, int func) |
| void | CutRefinedFace (gl3::GlDrawable &target, const DenseMatrix &verts, const Vector &vert_dist, const Vector &vals, const Geometry::Type geom, const int *faces, int num_faces) |
| void | CPPrepare () |
| void | CPMoved () |
| void | PrepareFlat2 () |
| void | PrepareLines2 () |
| virtual void | PrepareCuttingPlane () |
| void | PrepareCuttingPlane2 () |
| void | PrepareCuttingPlaneLines () |
| void | PrepareCuttingPlaneLines2 () |
| void | PrepareLevelSurf () |
| void | ToggleCuttingPlane () |
| void | ToggleCPDrawElems () |
| void | ToggleCPDrawMesh () |
| void | ToggleCPAlgorithm () |
| void | MoveLevelSurf (int) |
| void | NumberOfLevelSurf (int) |
| virtual void | EventUpdateColors () |
| virtual void | UpdateLevelLines () |
| virtual void | UpdateValueRange (bool prepare) |
| virtual void | SetDrawMesh (int i) |
| virtual int | GetDrawMesh () |
Public Member Functions inherited from VisualizationSceneScalarData | |
| VisualizationSceneScalarData () | |
| VisualizationSceneScalarData (Mesh &m, Vector &s) | |
| virtual | ~VisualizationSceneScalarData () |
| virtual void | SetNewScalingFromBox () |
| virtual void | FindNewBoxAndValueRange (bool prepare) |
| virtual void | FindMeshBox (bool prepare) |
| void | DoAutoscale (bool prepare) |
| void | DoAutoscaleValue (bool prepare) |
| void | UpdateBoundingBox () |
| virtual void | EventUpdateBackground () |
| 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 () |
| virtual void | ToggleLogscale (bool print) |
| void | ToggleRuler () |
| void | RulerPosition () |
| 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 | TimesToRefine |
| double | FaceShiftScale |
| Array< int > | bdr_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 | GetFaceNormals (const int FaceNo, const int side, const IntegrationRule &ir, DenseMatrix &normals) |
| void | DrawRefinedSurf (int n, double *points, int elem, int func, int part=-1) |
| void | DrawRefinedSurf (int n, DenseMatrix &pointmat, Vector &values, Array< int > &RefGeoms) |
| void | DrawRefinedSurfLevelLines (int n, DenseMatrix &pointmat, Vector &values, Array< int > &RefGeoms) |
| void | DrawRefinedSurfEdges (int n, DenseMatrix &pointmat, Vector &values, Array< int > &RefEdges, int part=-1) |
| void | LiftRefinedSurf (int n, DenseMatrix &pointmat, Vector &values, int *RG) |
| void | DrawTetLevelSurf (gl3::GlDrawable &target, const DenseMatrix &verts, const Vector &vals, const int *ind, const Array< double > &levels, const DenseMatrix *grad=NULL) |
| void | DrawRefinedPyramidLevelSurf (gl3::GlDrawable &target, const DenseMatrix &verts, const Vector &vals, const int *RG, const int np, const int face_splits, const DenseMatrix *grad=NULL) |
| void | DrawRefinedWedgeLevelSurf (gl3::GlDrawable &target, const DenseMatrix &verts, const Vector &vals, const int *RG, const int np, const int face_splits, const DenseMatrix *grad=NULL) |
| void | DrawRefinedHexLevelSurf (gl3::GlDrawable &target, const DenseMatrix &verts, const Vector &vals, const int *RG, const int nh, const int face_splits, const DenseMatrix *grad=NULL) |
| int | GetAutoRefineFactor () |
| bool | CheckPositions (Array< int > &vertices) const |
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) |
Static Protected Member Functions | |
| static int | GetPyramidFaceSplits (const Array< bool > &quad_diag, const Array< int > &faces, const Array< int > &ofaces) |
| static int | GetWedgeFaceSplits (const Array< bool > &quad_diag, const Array< int > &faces, const Array< int > &ofaces) |
| static int | GetHexFaceSplits (const Array< bool > &quad_diag, const Array< int > &faces, const Array< int > &ofaces) |
Additional Inherited Members | |
Protected Types inherited from VisualizationScene | |
| enum | { BG_BLK = 0, BG_WHITE = 1 } |
Definition at line 21 of file vssolution3d.hpp.
| VisualizationSceneSolution3d::VisualizationSceneSolution3d | ( | ) |
Definition at line 681 of file vssolution3d.cpp.
| VisualizationSceneSolution3d::VisualizationSceneSolution3d | ( | Mesh & | m, |
| Vector & | s | ||
| ) |
Definition at line 684 of file vssolution3d.cpp.
|
virtual |
Definition at line 807 of file vssolution3d.cpp.
|
virtual |
Implements VisualizationSceneScalarData.
Definition at line 924 of file vssolution3d.cpp.
|
inlineprotected |
Definition at line 98 of file vssolution3d.hpp.
| void VisualizationSceneSolution3d::CPMoved | ( | ) |
Definition at line 252 of file vssolution3d.cpp.
| void VisualizationSceneSolution3d::CPPrepare | ( | ) |
Definition at line 246 of file vssolution3d.cpp.
| void VisualizationSceneSolution3d::CutRefinedElement | ( | gl3::GlDrawable & | target, |
| const DenseMatrix & | verts, | ||
| const Vector & | vert_dist, | ||
| const Vector & | vals, | ||
| const Geometry::Type | geom, | ||
| const int * | elems, | ||
| int | num_elems, | ||
| int | func | ||
| ) |
Definition at line 2618 of file vssolution3d.cpp.
| void VisualizationSceneSolution3d::CutRefinedFace | ( | gl3::GlDrawable & | target, |
| const DenseMatrix & | verts, | ||
| const Vector & | vert_dist, | ||
| const Vector & | vals, | ||
| const Geometry::Type | geom, | ||
| const int * | faces, | ||
| int | num_faces | ||
| ) |
Definition at line 2745 of file vssolution3d.cpp.
| void VisualizationSceneSolution3d::CuttingPlaneFunc | ( | int | type | ) |
Definition at line 2459 of file vssolution3d.cpp.
|
protected |
Definition at line 3591 of file vssolution3d.cpp.
|
protected |
Definition at line 3291 of file vssolution3d.cpp.
|
protected |
Definition at line 1200 of file vssolution3d.cpp.
|
protected |
Definition at line 1326 of file vssolution3d.cpp.
|
protected |
Definition at line 1368 of file vssolution3d.cpp.
|
protected |
Definition at line 1397 of file vssolution3d.cpp.
|
protected |
Definition at line 3445 of file vssolution3d.cpp.
|
protected |
Definition at line 3109 of file vssolution3d.cpp.
|
virtual |
Reimplemented from VisualizationSceneScalarData.
Reimplemented in VisualizationSceneVector3d.
Definition at line 1044 of file vssolution3d.cpp.
|
virtual |
Implements VisualizationSceneScalarData.
Definition at line 962 of file vssolution3d.cpp.
|
virtual |
Implements VisualizationSceneScalarData.
Definition at line 1028 of file vssolution3d.cpp.
| void VisualizationSceneSolution3d::FindNodePos | ( | ) |
Definition at line 1069 of file vssolution3d.cpp.
|
protected |
Definition at line 908 of file vssolution3d.cpp.
|
inlinevirtual |
Definition at line 197 of file vssolution3d.hpp.
|
protected |
Definition at line 1157 of file vssolution3d.cpp.
|
virtual |
Reimplemented from VisualizationSceneScalarData.
Reimplemented in VisualizationSceneVector3d.
Definition at line 38 of file vssolution3d.cpp.
|
staticprotected |
Definition at line 3574 of file vssolution3d.cpp.
|
staticprotected |
Definition at line 3277 of file vssolution3d.cpp.
|
virtual |
Reimplemented from VisualizationSceneScalarData.
Reimplemented in VisualizationSceneVector3d.
Definition at line 3940 of file vssolution3d.cpp.
|
inline |
Definition at line 151 of file vssolution3d.hpp.
|
staticprotected |
Definition at line 3428 of file vssolution3d.cpp.
|
virtual |
Reimplemented from VisualizationSceneScalarData.
Definition at line 4006 of file vssolution3d.cpp.
|
protected |
Definition at line 694 of file vssolution3d.cpp.
|
protected |
Definition at line 1267 of file vssolution3d.cpp.
| void VisualizationSceneSolution3d::MoveLevelSurf | ( | int | move | ) |
Definition at line 1133 of file vssolution3d.cpp.
| void VisualizationSceneSolution3d::NewMeshAndSolution | ( | Mesh * | new_m, |
| Vector * | new_sol, | ||
| GridFunction * | new_u = NULL |
||
| ) |
Definition at line 812 of file vssolution3d.cpp.
| void VisualizationSceneSolution3d::NumberOfLevelSurf | ( | int | c | ) |
Definition at line 1147 of file vssolution3d.cpp.
|
virtual |
Implements VisualizationSceneScalarData.
Reimplemented in VisualizationSceneVector3d.
Definition at line 1786 of file vssolution3d.cpp.
|
virtual |
Reimplemented in VisualizationSceneVector3d.
Definition at line 2818 of file vssolution3d.cpp.
| void VisualizationSceneSolution3d::PrepareCuttingPlane2 | ( | ) |
Definition at line 2857 of file vssolution3d.cpp.
| void VisualizationSceneSolution3d::PrepareCuttingPlaneLines | ( | ) |
Definition at line 2931 of file vssolution3d.cpp.
| void VisualizationSceneSolution3d::PrepareCuttingPlaneLines2 | ( | ) |
Definition at line 3020 of file vssolution3d.cpp.
|
virtual |
Reimplemented in VisualizationSceneVector3d.
Definition at line 1422 of file vssolution3d.cpp.
| void VisualizationSceneSolution3d::PrepareFlat2 | ( | ) |
Definition at line 1617 of file vssolution3d.cpp.
| void VisualizationSceneSolution3d::PrepareLevelSurf | ( | ) |
Definition at line 3791 of file vssolution3d.cpp.
|
virtual |
Implements VisualizationSceneScalarData.
Reimplemented in VisualizationSceneVector3d.
Definition at line 1963 of file vssolution3d.cpp.
| void VisualizationSceneSolution3d::PrepareLines2 | ( | ) |
Definition at line 2052 of file vssolution3d.cpp.
|
virtual |
Definition at line 131 of file vssolution3d.cpp.
|
virtual |
Definition at line 143 of file vssolution3d.cpp.
|
inlinevirtual |
Reimplemented from VisualizationSceneScalarData.
Definition at line 129 of file vssolution3d.hpp.
|
inlinevirtual |
Definition at line 189 of file vssolution3d.hpp.
|
inline |
Definition at line 117 of file vssolution3d.hpp.
|
virtual |
Implements VisualizationSceneScalarData.
Definition at line 889 of file vssolution3d.cpp.
|
virtual |
Implements VisualizationSceneScalarData.
Definition at line 847 of file vssolution3d.cpp.
|
virtual |
Implements VisualizationSceneScalarData.
Definition at line 933 of file vssolution3d.cpp.
| void VisualizationSceneSolution3d::ToggleCPAlgorithm | ( | ) |
Definition at line 1124 of file vssolution3d.cpp.
| void VisualizationSceneSolution3d::ToggleCPDrawElems | ( | ) |
Definition at line 1105 of file vssolution3d.cpp.
| void VisualizationSceneSolution3d::ToggleCPDrawMesh | ( | ) |
Definition at line 1111 of file vssolution3d.cpp.
| void VisualizationSceneSolution3d::ToggleCuttingPlane | ( | ) |
Definition at line 1085 of file vssolution3d.cpp.
|
inline |
Definition at line 141 of file vssolution3d.hpp.
| void VisualizationSceneSolution3d::ToggleDrawMesh | ( | ) |
Definition at line 1079 of file vssolution3d.cpp.
|
inline |
Definition at line 148 of file vssolution3d.hpp.
| void VisualizationSceneSolution3d::ToggleShading | ( | ) |
Definition at line 877 of file vssolution3d.cpp.
|
inlinevirtual |
Implements VisualizationSceneScalarData.
Definition at line 185 of file vssolution3d.hpp.
|
virtual |
Implements VisualizationSceneScalarData.
Definition at line 1056 of file vssolution3d.cpp.
| Array<int> VisualizationSceneSolution3d::bdr_attr_to_show |
Definition at line 112 of file vssolution3d.hpp.
|
protected |
Definition at line 31 of file vssolution3d.hpp.
|
protected |
Definition at line 27 of file vssolution3d.hpp.
|
protected |
Definition at line 27 of file vssolution3d.hpp.
|
protected |
Definition at line 26 of file vssolution3d.hpp.
|
protected |
Definition at line 35 of file vssolution3d.hpp.
|
protected |
Definition at line 36 of file vssolution3d.hpp.
|
protected |
Definition at line 33 of file vssolution3d.hpp.
|
protected |
Definition at line 25 of file vssolution3d.hpp.
|
protected |
Definition at line 27 of file vssolution3d.hpp.
|
protected |
Definition at line 25 of file vssolution3d.hpp.
|
protected |
Definition at line 25 of file vssolution3d.hpp.
| double VisualizationSceneSolution3d::FaceShiftScale |
Definition at line 110 of file vssolution3d.hpp.
|
protected |
Definition at line 46 of file vssolution3d.hpp.
|
protected |
Definition at line 44 of file vssolution3d.hpp.
|
protected |
Definition at line 34 of file vssolution3d.hpp.
|
protected |
Definition at line 37 of file vssolution3d.hpp.
|
protected |
Definition at line 43 of file vssolution3d.hpp.
|
protected |
Definition at line 41 of file vssolution3d.hpp.
|
protected |
Definition at line 39 of file vssolution3d.hpp.
|
protected |
Definition at line 39 of file vssolution3d.hpp.
|
protected |
Definition at line 38 of file vssolution3d.hpp.
|
protected |
Definition at line 25 of file vssolution3d.hpp.
| int VisualizationSceneSolution3d::TimesToRefine |
Definition at line 109 of file vssolution3d.hpp.
1.8.5