CSE351/ IT351 Modeling and Simulation

Slides:



Advertisements
Similar presentations
CHAPTER 1: COMPUTATIONAL MODELLING
Advertisements

Steady-state heat conduction on triangulated planar domain May, 2002
Fluent Overview Ahmadi/Nazridoust ME 437/537/637.
Compatible Spatial Discretizations for Partial Differential Equations May 14, 2004 Compatible Reconstruction of Vectors Blair Perot Dept. of Mechanical.
CSE554Cell ComplexesSlide 1 CSE 554 Lecture 3: Shape Analysis (Part II) Fall 2014.
Isoparametric Elements Element Stiffness Matrices
Element Loads Strain and Stress 2D Analyses Structural Mechanics Displacement-based Formulations.
ELEN 3371 Electromagnetics Fall Lecture 6: Maxwell’s Equations Instructor: Dr. Gleb V. Tcheslavski Contact: Office.
Beams and Frames.
CS 351/ IT 351 Modeling and Simulation Technologies Errors In Models Dr. Jim Holten.
Some Ideas Behind Finite Element Analysis
Lectures on CFD Fundamental Equations
By S Ziaei-Rad Mechanical Engineering Department, IUT.
Raster Based GIS Analysis
Post-processing J.Cugnoni, LMAF/EPFL, Finite element « outputs » Essential variables:  Displacement u, temperature T find u such that : K u = f.
A Bezier Based Approach to Unstructured Moving Meshes ALADDIN and Sangria Gary Miller David Cardoze Todd Phillips Noel Walkington Mark Olah Miklos Bergou.
ECIV 720 A Advanced Structural Mechanics and Analysis
CS 584. Review n Systems of equations and finite element methods are related.
CSE351/ IT351 Modeling And Simulation Choosing a Mesh Model Dr. Jim Holten.
2003 by Jim X. Chen: Introduction to Modeling Jim X. Chen George Mason University.
Scientific Visualization Data Modelling for Scientific Visualization CS 5630 / 6630 August 28, 2007.
E. WES BETHEL (LBNL), CHRIS JOHNSON (UTAH), KEN JOY (UC DAVIS), SEAN AHERN (ORNL), VALERIO PASCUCCI (LLNL), JONATHAN COHEN (LLNL), MARK DUCHAINEAU.
Fluids. Eulerian View  In a Lagrangian view each body is described at each point in space. Difficult for a fluid with many particles.  In an Eulerian.
MCE 561 Computational Methods in Solid Mechanics
Collision Detection David Johnson Cs6360 – Virtual Reality.
III Solution of pde’s using variational principles
1 Finite-Volume Formulation. 2 Review of the Integral Equation The integral equation for the conservation statement is: Equation applies for a control.
Introduction to virtual engineering László Horváth Budapest Tech John von Neumann Faculty of Informatics Institute of Intelligent Engineering.
A Study of The Applications of Matrices and R^(n) Projections By Corey Messonnier.
S.S. Yang and J.K. Lee FEMLAB and its applications POSTEC H Plasma Application Modeling Lab. Oct. 25, 2005.
© Fluent Inc. 9/20/ Introductory FLUENT Notes FLUENT v6.0 Jan 2002 Fluent User Services Center Solver Basics.
Finite Element Method.
Haptics and Virtual Reality
Mesh Generation 58:110 Computer-Aided Engineering Reference: Lecture Notes on Delaunay Mesh Generation, J. Shewchuk (1999)
Discontinuous Galerkin Methods and Strand Mesh Generation
A conservative FE-discretisation of the Navier-Stokes equation JASS 2005, St. Petersburg Thomas Satzger.
Magnet Design for Neutron Interferometry By: Rob Milburn.
A particle-gridless hybrid methods for incompressible flows
ME 254. Chapter I Integral Relations for a Control Volume An engineering science like fluid dynamics rests on foundations comprising both theory and experiment.
11/11/20151 Trusses. 11/11/20152 Element Formulation by Virtual Work u Use virtual work to derive element stiffness matrix based on assumed displacements.
CFX-10 Introduction Lecture 1.
Characteristic vibrations of the field. LL2 section 52.
HEAT TRANSFER FINITE ELEMENT FORMULATION
MA354 An Introduction to Math Models (more or less corresponding to 1.0 in your book)
Quantum Two 1. 2 Angular Momentum and Rotations 3.
Outline Introduction Research Project Findings / Results
Discretization Methods Chapter 2. Training Manual May 15, 2001 Inventory # Discretization Methods Topics Equations and The Goal Brief overview.
BOĞAZİÇİ UNIVERSITY – COMPUTER ENGINEERING Mehmet Balman Computer Engineering, Boğaziçi University Parallel Tetrahedral Mesh Refinement.
Physically based deformations of implicit surfaces Michal Remiš.
CS 351/ IT 351 Modeling and Simulation Technologies Review ( ) Dr. Jim Holten.
Haptic Deformation Modelling Through Cellular Neural Network YONGMIN ZHONG, BIJAN SHIRINZADEH, GURSEL ALICI, JULIAN SMITH.
Multiplication of vectors Two different interactions (what’s the difference?)  Scalar or dot product : the calculation giving the work done by a force.
2/24/2016 A.Aruna/Assistant professor/IT/SNSCE 1.
A Fully Conservative 2D Model over Evolving Geometries Ricardo Canelas Master degree student IST Teton Dam 1976.
CSE 872 Dr. Charles B. Owen Advanced Computer Graphics1 Water Computational Fluid Dynamics Volumes Lagrangian vs. Eulerian modelling Navier-Stokes equations.
3D Object Representations 2009, Fall. Introduction What is CG?  Imaging : Representing 2D images  Modeling : Representing 3D objects  Rendering : Constructing.
Modelling & Simulation of Semiconductor Devices Lecture 1 & 2 Introduction to Modelling & Simulation.
1 CHAP 3 WEIGHTED RESIDUAL AND ENERGY METHOD FOR 1D PROBLEMS FINITE ELEMENT ANALYSIS AND DESIGN Nam-Ho Kim.
Lecture 6: Maxwell’s Equations
Modeling and Simulation Dr. Mohammad Kilani
Continuum Mechanics (MTH487)
Chapter 6 The Traditional Approach to Requirements.
Introduction to the Finite Element Method
ELEC 3105 Basic EM and Power Engineering
Maxwell’s Equations.
Using Flow Textures to Visualize Unsteady Vector Fields
Fluent Overview Ahmadi/Nazridoust ME 437/537/637.
GENERAL VIEW OF KRATOS MULTIPHYSICS
OVERVIEW OF FINITE ELEMENT METHOD
Ph.D. Thesis Numerical Solution of PDEs and Their Object-oriented Parallel Implementations Xing Cai October 26, 1998.
Presentation transcript:

CSE351/ IT351 Modeling and Simulation Mesh Models Dr. Jim Holten

Mesh Models Background – Representing data from the real world Mesh Types Model Implementation via Matrices Model Implementation using SRF

Background How do we represent a continuum? How do we represent a deformable object? How do we represent disjoint parts?

Representing a Continuum Field equations (analytical) Mesh points (discrete locations) Mesh “cells” (discrete objects) Combinations

Continuum Field Equations Gravitation Electric charges Magnetic fields Evenly propagated point source radiated energy

Continuum Mesh Points Attributed values at each point Fixed grid points Mobile grid points Arbitrary (strategically placed) points Multi-mesh points

Continuum Mesh Combinations Objects, particles, and fields Radiation transport and collisions Protein models Satellite orbits Integrated systems Boundary transports

Continuum Mesh Cells Point locations and attributes Attribute values over line, surface, or volume regions (1-D, 2-D, or 3-D) May form a hierarchy of cell types Node (Point) Edge (Line between points) Face (Surface bounded by lines) Zone (Volume bounded by surfaces)

Mesh Cell Behavior Types Fixed positions (Eulerian Mesh) Adaptive positions (Lagrangian Mesh) Crushing collision surface Wavefront deformation Adaptive refinement for finer localized representation Assemblies of parts Separate “independent objects” Boundaries

Implementing a Mesh Model Choose a model object representation Represent the state variables (properties of the represented objects) Organize the model calculations (state variable calculations for each time step) Decide how to view the time step values

State Variables State variables are EVERY variable that changes over time and must be carried from time step to time step. State variables are mostly “attributes” (properties) of the elements. State variables generally are in vectors whose value entries correspond to the cells in a single cell set.

State Variable Representations Each has its own data type, depending on what it represents. Commonly float or double, may also be integer, enumerated value, vector, string, or ... Generally loosely interpreted as meaning ANY attribute of an element or of the model itself.

State Variable Calculations Inputs to calculations: State variable values (one or many) Constants and coefficients Element associations Outputs New state variable values

State Variable Calculations Temporary variables may or may not be considered state variables. Calculations may be iterated many times over for each of many inputs (A differential equation solver or integrator) or be simple expression evaluation as in (a = b). A state variable could be the state of a lesser (limited scope) Finite State Machine.

State Variable Calculations Generally best to organize the calculations to iterate through the output values, calculating each before going on. Each mesh cell has its own state variables, and it often is best to compute all for one cell at a time, but some algorithms require one attribute for all cells before the next attribute can be calculated.

State Variable Calculations Selecting the order to do calculations among attributes can be a precedence-based scheduling problem. Work to keep it as simple as possible!! Use comments to inform source code readers why you have used a specific ordering or technique!

Choose a Model Object Representation Finite Elements? (Pick from a zoo of predefined cell element types) Regular Polyhedral Mesh? (Homogeneous mesh cells) General Polyhedral Mesh? (Hierarchy of generalized cells) Any combination of the above?

Model Cell Criteria Cell shapes? Cell properties (attributes)? Cell associations with neighbor cells? Cell associations with other cell set members? Complexities of developing supporting code?

Finite Element Cell Types 1-D: Line, interpolated line, spline 2-D: Triangle, rectangle, trapezoid, circle, ellipse, interpolated shape variations 3-D: Tetrahedral, hexahedral, spherical, ellipsoidal Special types: Springs, shock absorbers, circuit components, other custom variations

Regular Polyhedral Cell Types Limited to “regular” shapes that will cover a “region”. 1-D: No problem. 2-D: Triangles, quadrangles, and hexagons only. 3-D: Hexahedrals only. Does not cover irregularly shaped model objects/parts.

General Polyhedral Cell Types A hierarchy of cells (nodes, edges, faces, and zones). 0-D: node (point) has a location (usually) 1-D: edge (line) connects two end points (nodes). 2-D: face is surrounded by edges. 3-D: zone is surrounded by faces. Fully generalized polyhedral shapes, allowing extreme shape representation.

Matrix Representations of Mesh Models Vectors Each is over a single cell set (which is always made up of a single cell type) Each contains values for a single property for each cell in the cell set Matrices Each matrix represents an association between values for a pair of cell sets Each may be a “flag” (1 or 0) or may have an association value (constant coefficient) Some are used as transformations to “relate” vector values in linear equations for the time step calculations Commonly used for sets of homogeneous cell types

Matrix Mesh Model Vectors Vectors of cell set member attributes (property values) One value for each cell in the cell set May be scalars, vectors, matrices, tensors, strings, enumerated values (hot/warm/cold, on/off, ...), or ? Examples Volume temperature, material makeup, mass, density, pressure, ... Point coordinates (1-D, 2-D, or 3-D usually) Each entry a vector of flow through a surface

Matrix Mesh Model Matrices Represent relations which indicate cell adjacency within a set of cells cell associations between cell sets May contain values representing Cell interaction properties (weights, coefficients) Linear state value propagator coefficients Stochastic covariance values for property values between cell pairs

Matrix Mesh Model Characteristics Most model matrices are sparse Matrix math does NOT handle nonlinearities well, so nonlinearities must be handled as separate expressions for each transformation. Matrix representations do NOT clearly indicate organization at higher levels of abstraction. It is easy to get lost in the code and data relationships at all levels. Parallel partitioning can be awkward.

Viewing Time Step Values Generally state variable combinations are valid only between (not during) time steps. That is when to view them (except for debugging purposes). Sometimes auxiliary state variables are created JUST so they can be viewed!!

Viewing Time Step Values Print the values. Plot the values. Use the values to adjust visual “meters” or other indicators. Use the values to adjust images on virtual displays. Save the values for a later animation. Postprocess the values for a custom view.