Sample records for general event-driven simulator

  1. DynamO: a free O(N) general event-driven molecular dynamics simulator.

    PubMed

    Bannerman, M N; Sargant, R; Lue, L

    2011-11-30

    Molecular dynamics algorithms for systems of particles interacting through discrete or "hard" potentials are fundamentally different to the methods for continuous or "soft" potential systems. Although many software packages have been developed for continuous potential systems, software for discrete potential systems based on event-driven algorithms are relatively scarce and specialized. We present DynamO, a general event-driven simulation package, which displays the optimal O(N) asymptotic scaling of the computational cost with the number of particles N, rather than the O(N) scaling found in most standard algorithms. DynamO provides reference implementations of the best available event-driven algorithms. These techniques allow the rapid simulation of both complex and large (>10(6) particles) systems for long times. The performance of the program is benchmarked for elastic hard sphere systems, homogeneous cooling and sheared inelastic hard spheres, and equilibrium Lennard-Jones fluids. This software and its documentation are distributed under the GNU General Public license and can be freely downloaded from http://marcusbannerman.co.uk/dynamo. Copyright © 2011 Wiley Periodicals, Inc.

  2. Event-driven simulation in SELMON: An overview of EDSE

    NASA Technical Reports Server (NTRS)

    Rouquette, Nicolas F.; Chien, Steve A.; Charest, Leonard, Jr.

    1992-01-01

    EDSE (event-driven simulation engine), a model-based event-driven simulator implemented for SELMON, a tool for sensor selection and anomaly detection in real-time monitoring is described. The simulator is used in conjunction with a causal model to predict future behavior of the model from observed data. The behavior of the causal model is interpreted as equivalent to the behavior of the physical system being modeled. An overview of the functionality of the simulator and the model-based event-driven simulation paradigm on which it is based is provided. Included are high-level descriptions of the following key properties: event consumption and event creation, iterative simulation, synchronization and filtering of monitoring data from the physical system. Finally, how EDSE stands with respect to the relevant open issues of discrete-event and model-based simulation is discussed.

  3. A General and Efficient Method for Incorporating Precise Spike Times in Globally Time-Driven Simulations

    PubMed Central

    Hanuschkin, Alexander; Kunkel, Susanne; Helias, Moritz; Morrison, Abigail; Diesmann, Markus

    2010-01-01

    Traditionally, event-driven simulations have been limited to the very restricted class of neuronal models for which the timing of future spikes can be expressed in closed form. Recently, the class of models that is amenable to event-driven simulation has been extended by the development of techniques to accurately calculate firing times for some integrate-and-fire neuron models that do not enable the prediction of future spikes in closed form. The motivation of this development is the general perception that time-driven simulations are imprecise. Here, we demonstrate that a globally time-driven scheme can calculate firing times that cannot be discriminated from those calculated by an event-driven implementation of the same model; moreover, the time-driven scheme incurs lower computational costs. The key insight is that time-driven methods are based on identifying a threshold crossing in the recent past, which can be implemented by a much simpler algorithm than the techniques for predicting future threshold crossings that are necessary for event-driven approaches. As run time is dominated by the cost of the operations performed at each incoming spike, which includes spike prediction in the case of event-driven simulation and retrospective detection in the case of time-driven simulation, the simple time-driven algorithm outperforms the event-driven approaches. Additionally, our method is generally applicable to all commonly used integrate-and-fire neuronal models; we show that a non-linear model employing a standard adaptive solver can reproduce a reference spike train with a high degree of precision. PMID:21031031

  4. Event-driven simulations of nonlinear integrate-and-fire neurons.

    PubMed

    Tonnelier, Arnaud; Belmabrouk, Hana; Martinez, Dominique

    2007-12-01

    Event-driven strategies have been used to simulate spiking neural networks exactly. Previous work is limited to linear integrate-and-fire neurons. In this note, we extend event-driven schemes to a class of nonlinear integrate-and-fire models. Results are presented for the quadratic integrate-and-fire model with instantaneous or exponential synaptic currents. Extensions to conductance-based currents and exponential integrate-and-fire neurons are discussed.

  5. A Spiking Neural Simulator Integrating Event-Driven and Time-Driven Computation Schemes Using Parallel CPU-GPU Co-Processing: A Case Study.

    PubMed

    Naveros, Francisco; Luque, Niceto R; Garrido, Jesús A; Carrillo, Richard R; Anguita, Mancia; Ros, Eduardo

    2015-07-01

    Time-driven simulation methods in traditional CPU architectures perform well and precisely when simulating small-scale spiking neural networks. Nevertheless, they still have drawbacks when simulating large-scale systems. Conversely, event-driven simulation methods in CPUs and time-driven simulation methods in graphic processing units (GPUs) can outperform CPU time-driven methods under certain conditions. With this performance improvement in mind, we have developed an event-and-time-driven spiking neural network simulator suitable for a hybrid CPU-GPU platform. Our neural simulator is able to efficiently simulate bio-inspired spiking neural networks consisting of different neural models, which can be distributed heterogeneously in both small layers and large layers or subsystems. For the sake of efficiency, the low-activity parts of the neural network can be simulated in CPU using event-driven methods while the high-activity subsystems can be simulated in either CPU (a few neurons) or GPU (thousands or millions of neurons) using time-driven methods. In this brief, we have undertaken a comparative study of these different simulation methods. For benchmarking the different simulation methods and platforms, we have used a cerebellar-inspired neural-network model consisting of a very dense granular layer and a Purkinje layer with a smaller number of cells (according to biological ratios). Thus, this cerebellar-like network includes a dense diverging neural layer (increasing the dimensionality of its internal representation and sparse coding) and a converging neural layer (integration) similar to many other biologically inspired and also artificial neural networks.

  6. Simulating large-scale pedestrian movement using CA and event driven model: Methodology and case study

    NASA Astrophysics Data System (ADS)

    Li, Jun; Fu, Siyao; He, Haibo; Jia, Hongfei; Li, Yanzhong; Guo, Yi

    2015-11-01

    Large-scale regional evacuation is an important part of national security emergency response plan. Large commercial shopping area, as the typical service system, its emergency evacuation is one of the hot research topics. A systematic methodology based on Cellular Automata with the Dynamic Floor Field and event driven model has been proposed, and the methodology has been examined within context of a case study involving the evacuation within a commercial shopping mall. Pedestrians walking is based on Cellular Automata and event driven model. In this paper, the event driven model is adopted to simulate the pedestrian movement patterns, the simulation process is divided into normal situation and emergency evacuation. The model is composed of four layers: environment layer, customer layer, clerk layer and trajectory layer. For the simulation of movement route of pedestrians, the model takes into account purchase intention of customers and density of pedestrians. Based on evacuation model of Cellular Automata with Dynamic Floor Field and event driven model, we can reflect behavior characteristics of customers and clerks at the situations of normal and emergency evacuation. The distribution of individual evacuation time as a function of initial positions and the dynamics of the evacuation process is studied. Our results indicate that the evacuation model using the combination of Cellular Automata with Dynamic Floor Field and event driven scheduling can be used to simulate the evacuation of pedestrian flows in indoor areas with complicated surroundings and to investigate the layout of shopping mall.

  7. NEVESIM: event-driven neural simulation framework with a Python interface.

    PubMed

    Pecevski, Dejan; Kappel, David; Jonke, Zeno

    2014-01-01

    NEVESIM is a software package for event-driven simulation of networks of spiking neurons with a fast simulation core in C++, and a scripting user interface in the Python programming language. It supports simulation of heterogeneous networks with different types of neurons and synapses, and can be easily extended by the user with new neuron and synapse types. To enable heterogeneous networks and extensibility, NEVESIM is designed to decouple the simulation logic of communicating events (spikes) between the neurons at a network level from the implementation of the internal dynamics of individual neurons. In this paper we will present the simulation framework of NEVESIM, its concepts and features, as well as some aspects of the object-oriented design approaches and simulation strategies that were utilized to efficiently implement the concepts and functionalities of the framework. We will also give an overview of the Python user interface, its basic commands and constructs, and also discuss the benefits of integrating NEVESIM with Python. One of the valuable capabilities of the simulator is to simulate exactly and efficiently networks of stochastic spiking neurons from the recently developed theoretical framework of neural sampling. This functionality was implemented as an extension on top of the basic NEVESIM framework. Altogether, the intended purpose of the NEVESIM framework is to provide a basis for further extensions that support simulation of various neural network models incorporating different neuron and synapse types that can potentially also use different simulation strategies.

  8. NEVESIM: event-driven neural simulation framework with a Python interface

    PubMed Central

    Pecevski, Dejan; Kappel, David; Jonke, Zeno

    2014-01-01

    NEVESIM is a software package for event-driven simulation of networks of spiking neurons with a fast simulation core in C++, and a scripting user interface in the Python programming language. It supports simulation of heterogeneous networks with different types of neurons and synapses, and can be easily extended by the user with new neuron and synapse types. To enable heterogeneous networks and extensibility, NEVESIM is designed to decouple the simulation logic of communicating events (spikes) between the neurons at a network level from the implementation of the internal dynamics of individual neurons. In this paper we will present the simulation framework of NEVESIM, its concepts and features, as well as some aspects of the object-oriented design approaches and simulation strategies that were utilized to efficiently implement the concepts and functionalities of the framework. We will also give an overview of the Python user interface, its basic commands and constructs, and also discuss the benefits of integrating NEVESIM with Python. One of the valuable capabilities of the simulator is to simulate exactly and efficiently networks of stochastic spiking neurons from the recently developed theoretical framework of neural sampling. This functionality was implemented as an extension on top of the basic NEVESIM framework. Altogether, the intended purpose of the NEVESIM framework is to provide a basis for further extensions that support simulation of various neural network models incorporating different neuron and synapse types that can potentially also use different simulation strategies. PMID:25177291

  9. Comments on event driven animation

    NASA Technical Reports Server (NTRS)

    Gomez, Julian E.

    1987-01-01

    Event driven animation provides a general method of describing controlling values for various computer animation techniques. A definition and comments are provided on genralizing motion description with events. Additional comments are also provided about the implementation of twixt.

  10. Synchronization of autonomous objects in discrete event simulation

    NASA Technical Reports Server (NTRS)

    Rogers, Ralph V.

    1990-01-01

    Autonomous objects in event-driven discrete event simulation offer the potential to combine the freedom of unrestricted movement and positional accuracy through Euclidean space of time-driven models with the computational efficiency of event-driven simulation. The principal challenge to autonomous object implementation is object synchronization. The concept of a spatial blackboard is offered as a potential methodology for synchronization. The issues facing implementation of a spatial blackboard are outlined and discussed.

  11. Event management for large scale event-driven digital hardware spiking neural networks.

    PubMed

    Caron, Louis-Charles; D'Haene, Michiel; Mailhot, Frédéric; Schrauwen, Benjamin; Rouat, Jean

    2013-09-01

    The interest in brain-like computation has led to the design of a plethora of innovative neuromorphic systems. Individually, spiking neural networks (SNNs), event-driven simulation and digital hardware neuromorphic systems get a lot of attention. Despite the popularity of event-driven SNNs in software, very few digital hardware architectures are found. This is because existing hardware solutions for event management scale badly with the number of events. This paper introduces the structured heap queue, a pipelined digital hardware data structure, and demonstrates its suitability for event management. The structured heap queue scales gracefully with the number of events, allowing the efficient implementation of large scale digital hardware event-driven SNNs. The scaling is linear for memory, logarithmic for logic resources and constant for processing time. The use of the structured heap queue is demonstrated on a field-programmable gate array (FPGA) with an image segmentation experiment and a SNN of 65,536 neurons and 513,184 synapses. Events can be processed at the rate of 1 every 7 clock cycles and a 406×158 pixel image is segmented in 200 ms. Copyright © 2013 Elsevier Ltd. All rights reserved.

  12. A new concept for simulation of vegetated land surface dynamics - Part 1: The event driven phenology model

    NASA Astrophysics Data System (ADS)

    Kovalskyy, V.; Henebry, G. M.

    2012-01-01

    Phenologies of the vegetated land surface are being used increasingly for diagnosis and prognosis of climate change consequences. Current prospective and retrospective phenological models stand far apart in their approaches to the subject. We report on an exploratory attempt to implement a phenological model based on a new event driven concept which has both diagnostic and prognostic capabilities in the same modeling framework. This Event Driven Phenological Model (EDPM) is shown to simulate land surface phenologies and phenophase transition dates in agricultural landscapes based on assimilation of weather data and land surface observations from spaceborne sensors. The model enables growing season phenologies to develop in response to changing environmental conditions and disturbance events. It also has the ability to ingest remotely sensed data to adjust its output to improve representation of the modeled variable. We describe the model and report results of initial testing of the EDPM using Level 2 flux tower records from the Ameriflux sites at Mead, Nebraska, USA, and at Bondville, Illinois, USA. Simulating the dynamics of normalized difference vegetation index based on flux tower data, the predictions by the EDPM show good agreement (RMSE < 0.08; r2 > 0.8) for maize and soybean during several growing seasons at different locations. This study presents the EDPM used in the companion paper (Kovalskyy and Henebry, 2011) in a coupling scheme to estimate daily actual evapotranspiration over multiple growing seasons.

  13. A new concept for simulation of vegetated land surface dynamics - Part 1: The event driven phenology model

    NASA Astrophysics Data System (ADS)

    Kovalskyy, V.; Henebry, G. M.

    2011-05-01

    Phenologies of the vegetated land surface are being used increasingly for diagnosis and prognosis of climate change consequences. Current prospective and retrospective phenological models stand far apart in their approaches to the subject. We report on an exploratory attempt to implement a phenological model based on a new event driven concept which has both diagnostic and prognostic capabilities in the same modeling framework. This Event Driven Phenological Model (EDPM) is shown to simulate land surface phenologies and phenophase transition dates in agricultural landscapes based on assimilation of weather data and land surface observations from spaceborne sensors. The model enables growing season phenologies to develop in response to changing environmental conditions and disturbance events. It also has the ability to ingest remotely sensed data to adjust its output to improve representation of the modeled variable. We describe the model and report results of initial testing of the EDPM using Level 2 flux tower records from the Ameriflux sites at Mead, Nebraska, USA, and at Bondville, Illinois, USA. Simulating the dynamics of normalized difference vegetation index based on flux tower data, the predictions by the EDPM show good agreement (RMSE < 0.08; r2>0.8) for maize and soybean during several growing seasons at different locations. This study presents the EDPM used in the companion paper (Kovalskyy and Henebry, 2011) in a coupling scheme to estimate daily actual evapotranspiration over multiple growing seasons.

  14. Event- and Time-Driven Techniques Using Parallel CPU-GPU Co-processing for Spiking Neural Networks

    PubMed Central

    Naveros, Francisco; Garrido, Jesus A.; Carrillo, Richard R.; Ros, Eduardo; Luque, Niceto R.

    2017-01-01

    Modeling and simulating the neural structures which make up our central neural system is instrumental for deciphering the computational neural cues beneath. Higher levels of biological plausibility usually impose higher levels of complexity in mathematical modeling, from neural to behavioral levels. This paper focuses on overcoming the simulation problems (accuracy and performance) derived from using higher levels of mathematical complexity at a neural level. This study proposes different techniques for simulating neural models that hold incremental levels of mathematical complexity: leaky integrate-and-fire (LIF), adaptive exponential integrate-and-fire (AdEx), and Hodgkin-Huxley (HH) neural models (ranged from low to high neural complexity). The studied techniques are classified into two main families depending on how the neural-model dynamic evaluation is computed: the event-driven or the time-driven families. Whilst event-driven techniques pre-compile and store the neural dynamics within look-up tables, time-driven techniques compute the neural dynamics iteratively during the simulation time. We propose two modifications for the event-driven family: a look-up table recombination to better cope with the incremental neural complexity together with a better handling of the synchronous input activity. Regarding the time-driven family, we propose a modification in computing the neural dynamics: the bi-fixed-step integration method. This method automatically adjusts the simulation step size to better cope with the stiffness of the neural model dynamics running in CPU platforms. One version of this method is also implemented for hybrid CPU-GPU platforms. Finally, we analyze how the performance and accuracy of these modifications evolve with increasing levels of neural complexity. We also demonstrate how the proposed modifications which constitute the main contribution of this study systematically outperform the traditional event- and time-driven techniques under

  15. Sawtooth events and O+ in the plasma sheet and boundary layer: CME- and SIR-driven events

    NASA Astrophysics Data System (ADS)

    Lund, E. J.; Nowrouzi, N.; Kistler, L. M.; Cai, X.; Liao, J.

    2017-12-01

    The role of ionospheric ions in sawtooth events is an open question. Simulations[1,2,3] suggest that O+ from the ionosphere produces a feedback mechanism for driving sawtooth events. However, observational evidence[4,5] suggest that the presence of O+ in the plasma sheet is neither necessary nor sufficient. In this study we investigate whether the solar wind driver of the geomagnetic storm has an effect on the result. Building on an earlier study[4] that used events for which Cluster data is available in the plasma sheet and boundary layer, we perform a superposed epoch analysis for coronal mass ejection (CME) driven storms and streaming interaction region (SIR) driven storms separately, to investigate the hypothesis that ionospheric O+ is an important contributor for CME-driven storms but not SIR-driven storms[2]. [1]O. J. Brambles et al. (2011), Science 332, 1183.[2]O. J. Brambles et al. (2013), JGR 118, 6026.[3]R. H. Varney et al. (2016), JGR 121, 9688.[4]J. Liao et al. (2014), JGR 119, 1572.[5]E. J. Lund et al. (2017), JGR, submitted.

  16. Simulation of a master-slave event set processor

    DOE Office of Scientific and Technical Information (OSTI.GOV)

    Comfort, J.C.

    1984-03-01

    Event set manipulation may consume a considerable amount of the computation time spent in performing a discrete-event simulation. One way of minimizing this time is to allow event set processing to proceed in parallel with the remainder of the simulation computation. The paper describes a multiprocessor simulation computer, in which all non-event set processing is performed by the principal processor (called the host). Event set processing is coordinated by a front end processor (the master) and actually performed by several other functionally identical processors (the slaves). A trace-driven simulation program modeling this system was constructed, and was run with tracemore » output taken from two different simulation programs. Output from this simulation suggests that a significant reduction in run time may be realized by this approach. Sensitivity analysis was performed on the significant parameters to the system (number of slave processors, relative processor speeds, and interprocessor communication times). A comparison between actual and simulation run times for a one-processor system was used to assist in the validation of the simulation. 7 references.« less

  17. On Mixed Data and Event Driven Design for Adaptive-Critic-Based Nonlinear $H_{\\infty}$ Control.

    PubMed

    Wang, Ding; Mu, Chaoxu; Liu, Derong; Ma, Hongwen

    2018-04-01

    In this paper, based on the adaptive critic learning technique, the control for a class of unknown nonlinear dynamic systems is investigated by adopting a mixed data and event driven design approach. The nonlinear control problem is formulated as a two-player zero-sum differential game and the adaptive critic method is employed to cope with the data-based optimization. The novelty lies in that the data driven learning identifier is combined with the event driven design formulation, in order to develop the adaptive critic controller, thereby accomplishing the nonlinear control. The event driven optimal control law and the time driven worst case disturbance law are approximated by constructing and tuning a critic neural network. Applying the event driven feedback control, the closed-loop system is built with stability analysis. Simulation studies are conducted to verify the theoretical results and illustrate the control performance. It is significant to observe that the present research provides a new avenue of integrating data-based control and event-triggering mechanism into establishing advanced adaptive critic systems.

  18. Dynamically adaptive data-driven simulation of extreme hydrological flows

    NASA Astrophysics Data System (ADS)

    Kumar Jain, Pushkar; Mandli, Kyle; Hoteit, Ibrahim; Knio, Omar; Dawson, Clint

    2018-02-01

    Hydrological hazards such as storm surges, tsunamis, and rainfall-induced flooding are physically complex events that are costly in loss of human life and economic productivity. Many such disasters could be mitigated through improved emergency evacuation in real-time and through the development of resilient infrastructure based on knowledge of how systems respond to extreme events. Data-driven computational modeling is a critical technology underpinning these efforts. This investigation focuses on the novel combination of methodologies in forward simulation and data assimilation. The forward geophysical model utilizes adaptive mesh refinement (AMR), a process by which a computational mesh can adapt in time and space based on the current state of a simulation. The forward solution is combined with ensemble based data assimilation methods, whereby observations from an event are assimilated into the forward simulation to improve the veracity of the solution, or used to invert for uncertain physical parameters. The novelty in our approach is the tight two-way coupling of AMR and ensemble filtering techniques. The technology is tested using actual data from the Chile tsunami event of February 27, 2010. These advances offer the promise of significantly transforming data-driven, real-time modeling of hydrological hazards, with potentially broader applications in other science domains.

  19. Hard Sphere Simulation by Event-Driven Molecular Dynamics: Breakthrough, Numerical Difficulty, and Overcoming the issues

    NASA Astrophysics Data System (ADS)

    Isobe, Masaharu

    Hard sphere/disk systems are among the simplest models and have been used to address numerous fundamental problems in the field of statistical physics. The pioneering numerical works on the solid-fluid phase transition based on Monte Carlo (MC) and molecular dynamics (MD) methods published in 1957 represent historical milestones, which have had a significant influence on the development of computer algorithms and novel tools to obtain physical insights. This chapter addresses the works of Alder's breakthrough regarding hard sphere/disk simulation: (i) event-driven molecular dynamics, (ii) long-time tail, (iii) molasses tail, and (iv) two-dimensional melting/crystallization. From a numerical viewpoint, there are serious issues that must be overcome for further breakthrough. Here, we present a brief review of recent progress in this area.

  20. Convection-Resolving Climate Change Simulations: Intensification of Heavy Hourly Precipitation Events

    NASA Astrophysics Data System (ADS)

    Ban, N.; Schmidli, J.; Schar, C.

    2014-12-01

    Reliable climate-change projections of extreme precipitation events are of great interest to decision makers, due to potentially important hydrological impacts such as floods, land slides and debris flows. Low-resolution climate models generally project increases of heavy precipitation events with climate change, but there are large uncertainties related to the limited spatial resolution and the parameterized representation of atmospheric convection. Here we employ a convection-resolving version of the COSMO model across an extended region (1100 km x 1100 km) covering the European Alps to investigate the differences between parameterized and explicit convection in climate-change scenarios. We conduct 10-year long integrations at resolutions of 12 and 2km. Validation using ERA-Interim driven simulations reveals major improvements with the 2km resolution, in particular regarding the diurnal cycle of mean precipitation and the representation of hourly extremes. In addition, 2km simulations replicate the observed super-adiabatic scaling at precipitation stations, i.e. peak hourly events increase faster with temperature than the Clausius-Clapeyron scaling of 7%/K (see Ban et al. 2014). Convection-resolving climate change scenarios are conducted using control (1991-2000) and scenario (2081-2090) simulations driven by a CMIP5 GCM (i.e. the MPI-ESM-LR) under the IPCC RCP8.5 scenario. Comparison between 12 and 2km resolutions with parameterized and explicit convection, respectively, reveals close agreement in terms of mean summer precipitation amounts (decrease by 30%), and regarding slight increases of heavy day-long events (amounting to 15% for 90th-percentile for wet-day precipitation). However, the different resolutions yield large differences regarding extreme hourly precipitation, with the 2km version projecting substantially faster increases of heavy hourly precipitation events (about 30% increases for 90th-percentile hourly events). Ban, N., J. Schmidli and C. Sch

  1. The three-dimensional Event-Driven Graphics Environment (3D-EDGE)

    NASA Technical Reports Server (NTRS)

    Freedman, Jeffrey; Hahn, Roger; Schwartz, David M.

    1993-01-01

    Stanford Telecom developed the Three-Dimensional Event-Driven Graphics Environment (3D-EDGE) for NASA GSFC's (GSFC) Communications Link Analysis and Simulation System (CLASS). 3D-EDGE consists of a library of object-oriented subroutines which allow engineers with little or no computer graphics experience to programmatically manipulate, render, animate, and access complex three-dimensional objects.

  2. Simulation of a Driven Dense Granular Gas

    NASA Astrophysics Data System (ADS)

    Bizon, Chris; Shattuck, M. D.; Swift, J. B.; Swinney, Harry L.

    1998-11-01

    Event driven particle simulations quantitatively reproduce the experimental results on vibrated granular layers, including the formation of standing wave patterns(C. Bizon, M.D. Shattuck, J.B. Swift, W.D. McCormick, and H.L. Swinney, Phys. Rev. Lett. 80), pp. 57-60 (1998). and secondary instabilities(J.R. deBruyn, C. Bizon, M.D. Shattuck, D. Goldman, J.B. Swift, and H.L. Swinney, Phys. Rev. Lett. 81) (1998), to appear. . In these simulations the velocity distributions are nearly Gaussian when scaled with the local fluctuational kinetic energy (granular temperature); this suggests that inelastic dense gas kinetic theory is applicable. We perform simulations of a two-dimensional granular gas that is homogeneously driven with fluctuating forces. We find that the equation of state differs from that of an elastic dense gas and that this difference is due to a change in the distribution of relative velocities at collisions. Granular thermal conductivity and viscosity are measured by allowing the fluctuating forces to have large scale spatial gradients.

  3. Data-driven Simulations of Magnetic Connectivity in Behind-the-Limb Gamma-ray Flares and Associated Coronal Mass Ejections

    NASA Astrophysics Data System (ADS)

    Jin, M.; Petrosian, V.; Liu, W.; Nitta, N.; Omodei, N.; Rubio da Costa, F.; Effenberger, F.; Li, G.; Pesce-Rollins, M.

    2017-12-01

    Recent Fermi detection of high-energy gamma-ray emission from the behind-the-limb (BTL) solar flares pose a puzzle on the particle acceleration and transport mechanisms in such events. Due to the large separation between the flare site and the location of gamma-ray emission, it is believed that the associated coronal mass ejections (CMEs) play an important role in accelerating and subsequently transporting particles back to the Sun to produce obseved gamma-rays. We explore this scenario by simulating the CME associated with a well-observed flare on 2014 September 1 about 40 degrees behind the east solar limb and by comparing the simulation and observational results. We utilize a data-driven global magnetohydrodynamics model (AWSoM: Alfven-wave Solar Model) to track the dynamical evolution of the global magnetic field during the event and investigate the magnetic connectivity between the CME/CME-driven shock and the Fermi emission region. Moreover, we derive the time-varying shock parameters (e.g., compression ratio, Alfven Mach number, and ThetaBN) over the area that is magnetically connected to the visible solar disk where Fermi gamma-ray emission originates. Our simulation shows that the visible solar disk develops connections both to the flare site and to the CME-driven shock during the eruption, which indicate that the CME's interaction with the global solar corona is critical for understanding such Fermi BTL events and gamma-ray flares in general. We discuss the causes and implications of Fermi BTL events, in the framework of a potential shift of paradigm on particle acceleration in solar flares/CMEs.

  4. Evolution and propagation of the July 23, 2012, CME-driven shock: A 3-D MHD simulation result

    NASA Astrophysics Data System (ADS)

    Wu, S. T.; Dryer, Ph D., M.; Liou, K.; Wu, C. C.

    2016-12-01

    The interplanetary shock associated with the July 23, 2012 CME event is studied with the H3DMHD 3-D magnetohydrodynamic (MHD) simulation model. This backside CME event has been actively studied, probably due to its extremely fast propagating speed ( 2000 km/s) and large magnetic field magnitude ( 100 nT) at 1 AU. Some workers even compared this even with the Carrington event. In this study we focus on the acceleration and deceleration of the shock at the cobpoints. The H3DMHD is a data (photospheric magnetic field) driven model, which combines the HAF kinematic model for regions sunward of 18 Rs and the 3DMHD ideal MHD model for antisunward of 18 Rs up to 1.5 AU. To simulate the CME a gaussian velocity pulse is manually applied to the inner simulation boundary at 2.5 Rs above the flare site, with the initial peak velocity ( 3000 km/s) taken from the coronagraph measurements. In situ measurements of the solar wind parameters at STEREO-A are used to validate the simulation result, in particular the arrival time of the shock at STEREO-A. It is found, for this particular event, the CME-driven shock strength varies significantly across the shock surface. In general, the shock strength slowly weakened while propagating outward but stayed hypersonic (> Mach 5) for a cone shape region of a few 10's of degrees surrounding the shock nose. We will discuss our result in the context of the acceleration/deceleration of shock in a much slower background solar wind and the relationship of the shock strength with the flux of solar energetic particles observed by STEREO-A.

  5. Supporting Beacon and Event-Driven Messages in Vehicular Platoons through Token-Based Strategies

    PubMed Central

    Uhlemann, Elisabeth

    2018-01-01

    Timely and reliable inter-vehicle communications is a critical requirement to support traffic safety applications, such as vehicle platooning. Furthermore, low-delay communications allow the platoon to react quickly to unexpected events. In this scope, having a predictable and highly effective medium access control (MAC) method is of utmost importance. However, the currently available IEEE 802.11p technology is unable to adequately address these challenges. In this paper, we propose a MAC method especially adapted to platoons, able to transmit beacons within the required time constraints, but with a higher reliability level than IEEE 802.11p, while concurrently enabling efficient dissemination of event-driven messages. The protocol circulates the token within the platoon not in a round-robin fashion, but based on beacon data age, i.e., the time that has passed since the previous collection of status information, thereby automatically offering repeated beacon transmission opportunities for increased reliability. In addition, we propose three different methods for supporting event-driven messages co-existing with beacons. Analysis and simulation results in single and multi-hop scenarios showed that, by providing non-competitive channel access and frequent retransmission opportunities, our protocol can offer beacon delivery within one beacon generation interval while fulfilling the requirements on low-delay dissemination of event-driven messages for traffic safety applications. PMID:29570676

  6. Supporting Beacon and Event-Driven Messages in Vehicular Platoons through Token-Based Strategies.

    PubMed

    Balador, Ali; Uhlemann, Elisabeth; Calafate, Carlos T; Cano, Juan-Carlos

    2018-03-23

    Timely and reliable inter-vehicle communications is a critical requirement to support traffic safety applications, such as vehicle platooning. Furthermore, low-delay communications allow the platoon to react quickly to unexpected events. In this scope, having a predictable and highly effective medium access control (MAC) method is of utmost importance. However, the currently available IEEE 802.11p technology is unable to adequately address these challenges. In this paper, we propose a MAC method especially adapted to platoons, able to transmit beacons within the required time constraints, but with a higher reliability level than IEEE 802.11p, while concurrently enabling efficient dissemination of event-driven messages. The protocol circulates the token within the platoon not in a round-robin fashion, but based on beacon data age, i.e., the time that has passed since the previous collection of status information, thereby automatically offering repeated beacon transmission opportunities for increased reliability. In addition, we propose three different methods for supporting event-driven messages co-existing with beacons. Analysis and simulation results in single and multi-hop scenarios showed that, by providing non-competitive channel access and frequent retransmission opportunities, our protocol can offer beacon delivery within one beacon generation interval while fulfilling the requirements on low-delay dissemination of event-driven messages for traffic safety applications.

  7. Data-driven event-by-event respiratory motion correction using TOF PET list-mode centroid of distribution

    NASA Astrophysics Data System (ADS)

    Ren, Silin; Jin, Xiao; Chan, Chung; Jian, Yiqiang; Mulnix, Tim; Liu, Chi; E Carson, Richard

    2017-06-01

    Data-driven respiratory gating techniques were developed to correct for respiratory motion in PET studies, without the help of external motion tracking systems. Due to the greatly increased image noise in gated reconstructions, it is desirable to develop a data-driven event-by-event respiratory motion correction method. In this study, using the Centroid-of-distribution (COD) algorithm, we established a data-driven event-by-event respiratory motion correction technique using TOF PET list-mode data, and investigated its performance by comparing with an external system-based correction method. Ten human scans with the pancreatic β-cell tracer 18F-FP-(+)-DTBZ were employed. Data-driven respiratory motions in superior-inferior (SI) and anterior-posterior (AP) directions were first determined by computing the centroid of all radioactive events during each short time frame with further processing. The Anzai belt system was employed to record respiratory motion in all studies. COD traces in both SI and AP directions were first compared with Anzai traces by computing the Pearson correlation coefficients. Then, respiratory gated reconstructions based on either COD or Anzai traces were performed to evaluate their relative performance in capturing respiratory motion. Finally, based on correlations of displacements of organ locations in all directions and COD information, continuous 3D internal organ motion in SI and AP directions was calculated based on COD traces to guide event-by-event respiratory motion correction in the MOLAR reconstruction framework. Continuous respiratory correction results based on COD were compared with that based on Anzai, and without motion correction. Data-driven COD traces showed a good correlation with Anzai in both SI and AP directions for the majority of studies, with correlation coefficients ranging from 63% to 89%. Based on the determined respiratory displacements of pancreas between end-expiration and end-inspiration from gated

  8. Data-driven event-by-event respiratory motion correction using TOF PET list-mode centroid of distribution.

    PubMed

    Ren, Silin; Jin, Xiao; Chan, Chung; Jian, Yiqiang; Mulnix, Tim; Liu, Chi; Carson, Richard E

    2017-06-21

    Data-driven respiratory gating techniques were developed to correct for respiratory motion in PET studies, without the help of external motion tracking systems. Due to the greatly increased image noise in gated reconstructions, it is desirable to develop a data-driven event-by-event respiratory motion correction method. In this study, using the Centroid-of-distribution (COD) algorithm, we established a data-driven event-by-event respiratory motion correction technique using TOF PET list-mode data, and investigated its performance by comparing with an external system-based correction method. Ten human scans with the pancreatic β-cell tracer 18 F-FP-(+)-DTBZ were employed. Data-driven respiratory motions in superior-inferior (SI) and anterior-posterior (AP) directions were first determined by computing the centroid of all radioactive events during each short time frame with further processing. The Anzai belt system was employed to record respiratory motion in all studies. COD traces in both SI and AP directions were first compared with Anzai traces by computing the Pearson correlation coefficients. Then, respiratory gated reconstructions based on either COD or Anzai traces were performed to evaluate their relative performance in capturing respiratory motion. Finally, based on correlations of displacements of organ locations in all directions and COD information, continuous 3D internal organ motion in SI and AP directions was calculated based on COD traces to guide event-by-event respiratory motion correction in the MOLAR reconstruction framework. Continuous respiratory correction results based on COD were compared with that based on Anzai, and without motion correction. Data-driven COD traces showed a good correlation with Anzai in both SI and AP directions for the majority of studies, with correlation coefficients ranging from 63% to 89%. Based on the determined respiratory displacements of pancreas between end-expiration and end-inspiration from gated

  9. Simulating flaring events in complex active regions driven by observed magnetograms

    NASA Astrophysics Data System (ADS)

    Dimitropoulou, M.; Isliker, H.; Vlahos, L.; Georgoulis, M. K.

    2011-05-01

    Context. We interpret solar flares as events originating in active regions that have reached the self organized critical state, by using a refined cellular automaton model with initial conditions derived from observations. Aims: We investigate whether the system, with its imposed physical elements, reaches a self organized critical state and whether well-known statistical properties of flares, such as scaling laws observed in the distribution functions of characteristic parameters, are reproduced after this state has been reached. Methods: To investigate whether the distribution functions of total energy, peak energy and event duration follow the expected scaling laws, we first applied a nonlinear force-free extrapolation that reconstructs the three-dimensional magnetic fields from two-dimensional vector magnetograms. We then locate magnetic discontinuities exceeding a threshold in the Laplacian of the magnetic field. These discontinuities are relaxed in local diffusion events, implemented in the form of cellular automaton evolution rules. Subsequent loading and relaxation steps lead the system to self organized criticality, after which the statistical properties of the simulated events are examined. Physical requirements, such as the divergence-free condition for the magnetic field vector, are approximately imposed on all elements of the model. Results: Our results show that self organized criticality is indeed reached when applying specific loading and relaxation rules. Power-law indices obtained from the distribution functions of the modeled flaring events are in good agreement with observations. Single power laws (peak and total flare energy) are obtained, as are power laws with exponential cutoff and double power laws (flare duration). The results are also compared with observational X-ray data from the GOES satellite for our active-region sample. Conclusions: We conclude that well-known statistical properties of flares are reproduced after the system has

  10. Requirements analysis for a hardware, discrete-event, simulation engine accelerator

    NASA Astrophysics Data System (ADS)

    Taylor, Paul J., Jr.

    1991-12-01

    An analysis of a general Discrete Event Simulation (DES), executing on the distributed architecture of an eight mode Intel PSC/2 hypercube, was performed. The most time consuming portions of the general DES algorithm were determined to be the functions associated with message passing of required simulation data between processing nodes of the hypercube architecture. A behavioral description, using the IEEE standard VHSIC Hardware Description and Design Language (VHDL), for a general DES hardware accelerator is presented. The behavioral description specifies the operational requirements for a DES coprocessor to augment the hypercube's execution of DES simulations. The DES coprocessor design implements the functions necessary to perform distributed discrete event simulations using a conservative time synchronization protocol.

  11. Heinrich events simulated across the glacial

    NASA Astrophysics Data System (ADS)

    Ziemen, F. A.; Mikolajewicz, U.

    2015-12-01

    Heinrich events are among the most prominent climate change events recorded in proxies across the northern hemisphere. They are the archetype of ice sheet — climate interactions on millennial time scales. Nevertheless, the exact mechanisms that cause Heinrich events are still under discussion, and their climatic consequences are far from being fully understood. We contribute to answering the open questions by studying Heinrich events in a coupled ice sheet model (ISM) atmosphere-ocean-vegetation general circulation model (AOVGCM) framework, where this variability occurs as part of the model generated internal variability. The setup consists of a northern hemisphere setup of the modified Parallel Ice Sheet Model (mPISM) coupled to the global AOVGCM ECHAM5/MPIOM/LPJ. The simulations were performed fully coupled and with transient orbital and greenhouse gas forcing. They span from several millennia before the last glacial maximum into the deglaciation. We analyze simulations where the ISM is coupled asynchronously to the AOVGCM and simulations where the ISM and the ocean model are coupled synchronously and the atmosphere model is coupled asynchronously to them. The modeled Heinrich events show a marked influence of the ice discharge on the Atlantic circulation and heat transport.

  12. Cross-diffusion-driven hydrodynamic instabilities in a double-layer system: General classification and nonlinear simulations

    NASA Astrophysics Data System (ADS)

    Budroni, M. A.

    2015-12-01

    Cross diffusion, whereby a flux of a given species entrains the diffusive transport of another species, can trigger buoyancy-driven hydrodynamic instabilities at the interface of initially stable stratifications. Starting from a simple three-component case, we introduce a theoretical framework to classify cross-diffusion-induced hydrodynamic phenomena in two-layer stratifications under the action of the gravitational field. A cross-diffusion-convection (CDC) model is derived by coupling the fickian diffusion formalism to Stokes equations. In order to isolate the effect of cross-diffusion in the convective destabilization of a double-layer system, we impose a starting concentration jump of one species in the bottom layer while the other one is homogeneously distributed over the spatial domain. This initial configuration avoids the concurrence of classic Rayleigh-Taylor or differential-diffusion convective instabilities, and it also allows us to activate selectively the cross-diffusion feedback by which the heterogeneously distributed species influences the diffusive transport of the other species. We identify two types of hydrodynamic modes [the negative cross-diffusion-driven convection (NCC) and the positive cross-diffusion-driven convection (PCC)], corresponding to the sign of this operational cross-diffusion term. By studying the space-time density profiles along the gravitational axis we obtain analytical conditions for the onset of convection in terms of two important parameters only: the operational cross-diffusivity and the buoyancy ratio, giving the relative contribution of the two species to the global density. The general classification of the NCC and PCC scenarios in such parameter space is supported by numerical simulations of the fully nonlinear CDC problem. The resulting convective patterns compare favorably with recent experimental results found in microemulsion systems.

  13. Complete event simulations of nuclear fission

    NASA Astrophysics Data System (ADS)

    Vogt, Ramona

    2015-10-01

    For many years, the state of the art for treating fission in radiation transport codes has involved sampling from average distributions. In these average fission models energy is not explicitly conserved and everything is uncorrelated because all particles are emitted independently. However, in a true fission event, the energies, momenta and multiplicities of the emitted particles are correlated. Such correlations are interesting for many modern applications. Event-by-event generation of complete fission events makes it possible to retain the kinematic information for all particles emitted: the fission products as well as prompt neutrons and photons. It is therefore possible to extract any desired correlation observables. Complete event simulations can be included in general Monte Carlo transport codes. We describe the general functionality of currently available fission event generators and compare results for several important observables. This work was performed under the auspices of the US DOE by LLNL, Contract DE-AC52-07NA27344. We acknowledge support of the Office of Defense Nuclear Nonproliferation Research and Development in DOE/NNSA.

  14. Input-driven versus turnover-driven controls of simulated changes in soil carbon due to land-use change

    NASA Astrophysics Data System (ADS)

    Nyawira, Sylvia; Nabel, Julia; Brovkin, Victor; Pongratz, Julia

    2017-04-01

    Modelling studies estimate a global loss in soil carbon caused by land-use changes (LUCs) over the last century. Although it is known that this loss stems from the changes in quantity of litter inputs from the vegetation to the soil (input-driven) and the changes in turnover of carbon in the soil (turnover-driven) associated with LUC, the individual contribution of these two controls to the total changes have not been assessed. Using the dynamic global vegetation model JSBACH, we apply a factor separation approach to isolate the contribution of the input-driven and turnover-driven changes, as well as their synergies, to the total changes in soil carbon from LUC. To assess how land management through crop and wood harvest influences the controls, we compare our results for simulations with and without land management. Our results reveal that for the afforested regions both the input-driven and turnover-driven changes generally result in soil carbon gain, whereas deforested regions exhibit a loss. However, for regions where croplands have increased at the expense of grasslands and pastures, the input-driven changes result in a loss that is partly offset by a gain via the turnover-driven changes. This gain stems from a decrease in the fire-related carbon losses when grasslands or pastures are replaced with croplands. Omitting land management reduces the carbon losses in regions where natural vegetation has been converted to croplands and enhances the gain in afforested regions. The global simulated losses are substantially reduced from 54.0 Pg C to 22.0 Pg C, with the input-driven losses reducing from 54.7 Pg C to 24.9 Pg C. Our study shows that the dominating control of soil carbon losses is through the input-driven changes, which are more directly influenced by human management than the turnover-driven ones.

  15. LCP method for a planar passive dynamic walker based on an event-driven scheme

    NASA Astrophysics Data System (ADS)

    Zheng, Xu-Dong; Wang, Qi

    2018-06-01

    The main purpose of this paper is to present a linear complementarity problem (LCP) method for a planar passive dynamic walker with round feet based on an event-driven scheme. The passive dynamic walker is treated as a planar multi-rigid-body system. The dynamic equations of the passive dynamic walker are obtained by using Lagrange's equations of the second kind. The normal forces and frictional forces acting on the feet of the passive walker are described based on a modified Hertz contact model and Coulomb's law of dry friction. The state transition problem of stick-slip between feet and floor is formulated as an LCP, which is solved with an event-driven scheme. Finally, to validate the methodology, four gaits of the walker are simulated: the stance leg neither slips nor bounces; the stance leg slips without bouncing; the stance leg bounces without slipping; the walker stands after walking several steps.

  16. LCP method for a planar passive dynamic walker based on an event-driven scheme

    NASA Astrophysics Data System (ADS)

    Zheng, Xu-Dong; Wang, Qi

    2018-02-01

    The main purpose of this paper is to present a linear complementarity problem (LCP) method for a planar passive dynamic walker with round feet based on an event-driven scheme. The passive dynamic walker is treated as a planar multi-rigid-body system. The dynamic equations of the passive dynamic walker are obtained by using Lagrange's equations of the second kind. The normal forces and frictional forces acting on the feet of the passive walker are described based on a modified Hertz contact model and Coulomb's law of dry friction. The state transition problem of stick-slip between feet and floor is formulated as an LCP, which is solved with an event-driven scheme. Finally, to validate the methodology, four gaits of the walker are simulated: the stance leg neither slips nor bounces; the stance leg slips without bouncing; the stance leg bounces without slipping; the walker stands after walking several steps.

  17. A Hybrid Adaptive Routing Algorithm for Event-Driven Wireless Sensor Networks

    PubMed Central

    Figueiredo, Carlos M. S.; Nakamura, Eduardo F.; Loureiro, Antonio A. F.

    2009-01-01

    Routing is a basic function in wireless sensor networks (WSNs). For these networks, routing algorithms depend on the characteristics of the applications and, consequently, there is no self-contained algorithm suitable for every case. In some scenarios, the network behavior (traffic load) may vary a lot, such as an event-driven application, favoring different algorithms at different instants. This work presents a hybrid and adaptive algorithm for routing in WSNs, called Multi-MAF, that adapts its behavior autonomously in response to the variation of network conditions. In particular, the proposed algorithm applies both reactive and proactive strategies for routing infrastructure creation, and uses an event-detection estimation model to change between the strategies and save energy. To show the advantages of the proposed approach, it is evaluated through simulations. Comparisons with independent reactive and proactive algorithms show improvements on energy consumption. PMID:22423207

  18. A hybrid adaptive routing algorithm for event-driven wireless sensor networks.

    PubMed

    Figueiredo, Carlos M S; Nakamura, Eduardo F; Loureiro, Antonio A F

    2009-01-01

    Routing is a basic function in wireless sensor networks (WSNs). For these networks, routing algorithms depend on the characteristics of the applications and, consequently, there is no self-contained algorithm suitable for every case. In some scenarios, the network behavior (traffic load) may vary a lot, such as an event-driven application, favoring different algorithms at different instants. This work presents a hybrid and adaptive algorithm for routing in WSNs, called Multi-MAF, that adapts its behavior autonomously in response to the variation of network conditions. In particular, the proposed algorithm applies both reactive and proactive strategies for routing infrastructure creation, and uses an event-detection estimation model to change between the strategies and save energy. To show the advantages of the proposed approach, it is evaluated through simulations. Comparisons with independent reactive and proactive algorithms show improvements on energy consumption.

  19. Event-Driven Random Back-Propagation: Enabling Neuromorphic Deep Learning Machines

    PubMed Central

    Neftci, Emre O.; Augustine, Charles; Paul, Somnath; Detorakis, Georgios

    2017-01-01

    An ongoing challenge in neuromorphic computing is to devise general and computationally efficient models of inference and learning which are compatible with the spatial and temporal constraints of the brain. One increasingly popular and successful approach is to take inspiration from inference and learning algorithms used in deep neural networks. However, the workhorse of deep learning, the gradient descent Gradient Back Propagation (BP) rule, often relies on the immediate availability of network-wide information stored with high-precision memory during learning, and precise operations that are difficult to realize in neuromorphic hardware. Remarkably, recent work showed that exact backpropagated gradients are not essential for learning deep representations. Building on these results, we demonstrate an event-driven random BP (eRBP) rule that uses an error-modulated synaptic plasticity for learning deep representations. Using a two-compartment Leaky Integrate & Fire (I&F) neuron, the rule requires only one addition and two comparisons for each synaptic weight, making it very suitable for implementation in digital or mixed-signal neuromorphic hardware. Our results show that using eRBP, deep representations are rapidly learned, achieving classification accuracies on permutation invariant datasets comparable to those obtained in artificial neural network simulations on GPUs, while being robust to neural and synaptic state quantizations during learning. PMID:28680387

  20. Event-Driven Random Back-Propagation: Enabling Neuromorphic Deep Learning Machines.

    PubMed

    Neftci, Emre O; Augustine, Charles; Paul, Somnath; Detorakis, Georgios

    2017-01-01

    An ongoing challenge in neuromorphic computing is to devise general and computationally efficient models of inference and learning which are compatible with the spatial and temporal constraints of the brain. One increasingly popular and successful approach is to take inspiration from inference and learning algorithms used in deep neural networks. However, the workhorse of deep learning, the gradient descent Gradient Back Propagation (BP) rule, often relies on the immediate availability of network-wide information stored with high-precision memory during learning, and precise operations that are difficult to realize in neuromorphic hardware. Remarkably, recent work showed that exact backpropagated gradients are not essential for learning deep representations. Building on these results, we demonstrate an event-driven random BP (eRBP) rule that uses an error-modulated synaptic plasticity for learning deep representations. Using a two-compartment Leaky Integrate & Fire (I&F) neuron, the rule requires only one addition and two comparisons for each synaptic weight, making it very suitable for implementation in digital or mixed-signal neuromorphic hardware. Our results show that using eRBP, deep representations are rapidly learned, achieving classification accuracies on permutation invariant datasets comparable to those obtained in artificial neural network simulations on GPUs, while being robust to neural and synaptic state quantizations during learning.

  1. Simulation and animation of sensor-driven robots.

    PubMed

    Chen, C; Trivedi, M M; Bidlack, C R

    1994-10-01

    Most simulation and animation systems utilized in robotics are concerned with simulation of the robot and its environment without simulation of sensors. These systems have difficulty in handling robots that utilize sensory feedback in their operation. In this paper, a new design of an environment for simulation, animation, and visualization of sensor-driven robots is presented. As sensor technology advances, increasing numbers of robots are equipped with various types of sophisticated sensors. The main goal of creating the visualization environment is to aid the automatic robot programming and off-line programming capabilities of sensor-driven robots. The software system will help the users visualize the motion and reaction of the sensor-driven robot under their control program. Therefore, the efficiency of the software development is increased, the reliability of the software and the operation safety of the robot are ensured, and the cost of new software development is reduced. Conventional computer-graphics-based robot simulation and animation software packages lack of capabilities for robot sensing simulation. This paper describes a system designed to overcome this deficiency.

  2. Simulation and animation of sensor-driven robots

    DOE Office of Scientific and Technical Information (OSTI.GOV)

    Chen, C.; Trivedi, M.M.; Bidlack, C.R.

    1994-10-01

    Most simulation and animation systems utilized in robotics are concerned with simulation of the robot and its environment without simulation of sensors. These systems have difficulty in handling robots that utilize sensory feedback in their operation. In this paper, a new design of an environment for simulation, animation, and visualization of sensor-driven robots is presented. As sensor technology advances, increasing numbers of robots are equipped with various types of sophisticated sensors. The main goal of creating the visualization environment is to aide the automatic robot programming and off-line programming capabilities of sensor-driven robots. The software system will help the usersmore » visualize the motion and reaction of the sensor-driven robot under their control program. Therefore, the efficiency of the software development is increased, the reliability of the software and the operation safety of the robot are ensured, and the cost of new software development is reduced. Conventional computer-graphics-based robot simulation and animation software packages lack of capabilities for robot sensing simulation. This paper describes a system designed to overcome this deficiency.« less

  3. Input-driven versus turnover-driven controls of simulated changes in soil carbon due to land-use change

    NASA Astrophysics Data System (ADS)

    Nyawira, S. S.; Nabel, J. E. M. S.; Brovkin, V.; Pongratz, J.

    2017-08-01

    Historical changes in soil carbon associated with land-use change (LUC) result mainly from the changes in the quantity of litter inputs to the soil and the turnover of carbon in soils. We use a factor separation technique to assess how the input-driven and turnover-driven controls, as well as their synergies, have contributed to historical changes in soil carbon associated with LUC. We apply this approach to equilibrium simulations of present-day and pre-industrial land use performed using the dynamic global vegetation model JSBACH. Our results show that both the input-driven and turnover-driven changes generally contribute to a gain in soil carbon in afforested regions and a loss in deforested regions. However, in regions where grasslands have been converted to croplands, we find an input-driven loss that is partly offset by a turnover-driven gain, which stems from a decrease in the fire-related carbon losses. Omitting land management through crop and wood harvest substantially reduces the global losses through the input-driven changes. Our study thus suggests that the dominating control of soil carbon losses is via the input-driven changes, which are more directly accessible to human management than the turnover-driven ones.

  4. Simulation of Orographically-Driven Precipitation in Southern California

    NASA Astrophysics Data System (ADS)

    Carpenter, T. M.; Georgakakos, K. P.

    2008-12-01

    The proximity of the Pacific Ocean to the Transverse and Peninsular Mountain Ranges of coastal Southern California may lead to significant, orographically-enhanced precipitation in the region. With abundant moisture, such as evidenced in Pineapple Express events or atmospheric rivers, this precipitation may lead to other hydrologic hazards as flash flooding, landslides or debris flows. Available precipitation observation networks are relatively sparse in the mountainous regions and often do not capture the spatial variation of these events with high resolution. This study aims to simulate the topographically-driven precipitation over Southern California with high spatial resolution using a simplified orographic precipitation model. The model employs potential theory flow to estimate steady state three-dimensional wind fields for given free stream velocity forcing winds, atmospheric moisture advection, and cloud and precipitation microphysics proposed by Kessler (1969). The advantage of this modeling set-up is the computational efficiency as compared to regional mesoscale models such as the MM5. For this application, the Southern California region, comprised of the counties of Santa Barbara, Ventura, Los Angeles, Orange, and San Diego, and portions of San Bernardino and Riverside counties, are modeled at a 3-km resolution. The orographic precipitation model is forced by free stream wind velocities given by the 700mb winds from the NCEP Reanalysis I dataset. Atmospheric moisture initial conditions are defined also by the NCEP Reanalysis I dataset, and updated 4x- daily with the available 6-hourly NCEP Reanalysis forcing. This paper presents a comparison of the simulated precipitation to observations for over a variety of spatial scales and over the historical wet season periods from October 2000 to April 2005. The comparison is made over several performance measurements including (a) the occurrence/non-occurrence of precipitation, (b) overall bias and correlation, (c

  5. Synchronous Parallel Emulation and Discrete Event Simulation System with Self-Contained Simulation Objects and Active Event Objects

    NASA Technical Reports Server (NTRS)

    Steinman, Jeffrey S. (Inventor)

    1998-01-01

    The present invention is embodied in a method of performing object-oriented simulation and a system having inter-connected processor nodes operating in parallel to simulate mutual interactions of a set of discrete simulation objects distributed among the nodes as a sequence of discrete events changing state variables of respective simulation objects so as to generate new event-defining messages addressed to respective ones of the nodes. The object-oriented simulation is performed at each one of the nodes by assigning passive self-contained simulation objects to each one of the nodes, responding to messages received at one node by generating corresponding active event objects having user-defined inherent capabilities and individual time stamps and corresponding to respective events affecting one of the passive self-contained simulation objects of the one node, restricting the respective passive self-contained simulation objects to only providing and receiving information from die respective active event objects, requesting information and changing variables within a passive self-contained simulation object by the active event object, and producing corresponding messages specifying events resulting therefrom by the active event objects.

  6. Synchronization Of Parallel Discrete Event Simulations

    NASA Technical Reports Server (NTRS)

    Steinman, Jeffrey S.

    1992-01-01

    Adaptive, parallel, discrete-event-simulation-synchronization algorithm, Breathing Time Buckets, developed in Synchronous Parallel Environment for Emulation and Discrete Event Simulation (SPEEDES) operating system. Algorithm allows parallel simulations to process events optimistically in fluctuating time cycles that naturally adapt while simulation in progress. Combines best of optimistic and conservative synchronization strategies while avoiding major disadvantages. Algorithm processes events optimistically in time cycles adapting while simulation in progress. Well suited for modeling communication networks, for large-scale war games, for simulated flights of aircraft, for simulations of computer equipment, for mathematical modeling, for interactive engineering simulations, and for depictions of flows of information.

  7. Exact event-driven implementation for recurrent networks of stochastic perfect integrate-and-fire neurons.

    PubMed

    Taillefumier, Thibaud; Touboul, Jonathan; Magnasco, Marcelo

    2012-12-01

    In vivo cortical recording reveals that indirectly driven neural assemblies can produce reliable and temporally precise spiking patterns in response to stereotyped stimulation. This suggests that despite being fundamentally noisy, the collective activity of neurons conveys information through temporal coding. Stochastic integrate-and-fire models delineate a natural theoretical framework to study the interplay of intrinsic neural noise and spike timing precision. However, there are inherent difficulties in simulating their networks' dynamics in silico with standard numerical discretization schemes. Indeed, the well-posedness of the evolution of such networks requires temporally ordering every neuronal interaction, whereas the order of interactions is highly sensitive to the random variability of spiking times. Here, we answer these issues for perfect stochastic integrate-and-fire neurons by designing an exact event-driven algorithm for the simulation of recurrent networks, with delayed Dirac-like interactions. In addition to being exact from the mathematical standpoint, our proposed method is highly efficient numerically. We envision that our algorithm is especially indicated for studying the emergence of polychronized motifs in networks evolving under spike-timing-dependent plasticity with intrinsic noise.

  8. System on chip module configured for event-driven architecture

    DOEpatents

    Robbins, Kevin; Brady, Charles E.; Ashlock, Tad A.

    2017-10-17

    A system on chip (SoC) module is described herein, wherein the SoC modules comprise a processor subsystem and a hardware logic subsystem. The processor subsystem and hardware logic subsystem are in communication with one another, and transmit event messages between one another. The processor subsystem executes software actors, while the hardware logic subsystem includes hardware actors, the software actors and hardware actors conform to an event-driven architecture, such that the software actors receive and generate event messages and the hardware actors receive and generate event messages.

  9. A geostatistical extreme-value framework for fast simulation of natural hazard events

    PubMed Central

    Stephenson, David B.

    2016-01-01

    We develop a statistical framework for simulating natural hazard events that combines extreme value theory and geostatistics. Robust generalized additive model forms represent generalized Pareto marginal distribution parameters while a Student’s t-process captures spatial dependence and gives a continuous-space framework for natural hazard event simulations. Efficiency of the simulation method allows many years of data (typically over 10 000) to be obtained at relatively little computational cost. This makes the model viable for forming the hazard module of a catastrophe model. We illustrate the framework by simulating maximum wind gusts for European windstorms, which are found to have realistic marginal and spatial properties, and validate well against wind gust measurements. PMID:27279768

  10. On the Role of Ionospheric Ions in Sawtooth Events

    NASA Astrophysics Data System (ADS)

    Lund, E. J.; Nowrouzi, N.; Kistler, L. M.; Cai, X.; Frey, H. U.

    2018-01-01

    Simulations have suggested that feedback of heavy ions originating in the ionosphere is an important mechanism for driving sawtooth injections. However, this feedback may only be necessary for events driven by coronal mass ejections (CMEs), whereas in events driven by streaming interaction regions (SIRs), solar wind variability may suffice to drive these injections. Here we present case studies of two sawtooth events for which in situ data are available in both the magnetotail (Cluster) and the nightside auroral region (FAST), as well as global auroral images (IMAGE). One event, on 1 October 2001, was driven by a CME; the other, on 24 October 2002, was driven by an SIR. The available data do not support the hypothesis that heavy ion feedback is necessary to drive either event. This result is consistent with simulations of the SIR-driven event but disagrees with simulation results for a different CME-driven event. We also find that in an overwhelming majority of the sawtooth injections for which Cluster tail data are available, the O+ observed in the tail comes from the cusp rather than the nightside auroral region, which further casts doubt on the hypothesis that ionospheric heavy ion feedback is the cause of sawtooth injections.

  11. Characterizing rare-event property distributions via replicate molecular dynamics simulations of proteins.

    PubMed

    Krishnan, Ranjani; Walton, Emily B; Van Vliet, Krystyn J

    2009-11-01

    As computational resources increase, molecular dynamics simulations of biomolecules are becoming an increasingly informative complement to experimental studies. In particular, it has now become feasible to use multiple initial molecular configurations to generate an ensemble of replicate production-run simulations that allows for more complete characterization of rare events such as ligand-receptor unbinding. However, there are currently no explicit guidelines for selecting an ensemble of initial configurations for replicate simulations. Here, we use clustering analysis and steered molecular dynamics simulations to demonstrate that the configurational changes accessible in molecular dynamics simulations of biomolecules do not necessarily correlate with observed rare-event properties. This informs selection of a representative set of initial configurations. We also employ statistical analysis to identify the minimum number of replicate simulations required to sufficiently sample a given biomolecular property distribution. Together, these results suggest a general procedure for generating an ensemble of replicate simulations that will maximize accurate characterization of rare-event property distributions in biomolecules.

  12. Simulations of material mixing in laser-driven reshock experiments

    NASA Astrophysics Data System (ADS)

    Haines, Brian M.; Grinstein, Fernando F.; Welser-Sherrill, Leslie; Fincke, James R.

    2013-02-01

    We perform simulations of a laser-driven reshock experiment [Welser-Sherrill et al., High Energy Density Phys. (unpublished)] in the strong-shock high energy-density regime to better understand material mixing driven by the Richtmyer-Meshkov instability. Validation of the simulations is based on direct comparison of simulation and radiographic data. Simulations are also compared with published direct numerical simulation and the theory of homogeneous isotropic turbulence. Despite the fact that the flow is neither homogeneous, isotropic nor fully turbulent, there are local regions in which the flow demonstrates characteristics of homogeneous isotropic turbulence. We identify and isolate these regions by the presence of high levels of turbulent kinetic energy (TKE) and vorticity. After reshock, our analysis shows characteristics consistent with those of incompressible isotropic turbulence. Self-similarity and effective Reynolds number assessments suggest that the results are reasonably converged at the finest resolution. Our results show that in shock-driven transitional flows, turbulent features such as self-similarity and isotropy only fully develop once de-correlation, characteristic vorticity distributions, and integrated TKE, have decayed significantly. Finally, we use three-dimensional simulation results to test the performance of two-dimensional Reynolds-averaged Navier-Stokes simulations. In this context, we also test a presumed probability density function turbulent mixing model extensively used in combustion applications.

  13. A model of nitrous oxide evolution from soil driven by rainfall events. I - Model structure and sensitivity. II - Model applications

    NASA Technical Reports Server (NTRS)

    Changsheng, LI; Frolking, Steve; Frolking, Tod A.

    1992-01-01

    Simulations of N2O and CO2 emissions from soils were conducted with a rain-event driven, process-oriented model (DNDC) of nitrogen and carbon cycling processes in soils. The magnitude and trends of simulated N2O (or N2O + N2) and CO2 emissions were consistent with the results obtained in field experiments. The successful simulation of these emissions from the range of soil types examined demonstrates that the DNDC will be a useful tool for the study of linkages among climate, soil-atmosphere interactions, land use, and trace gas fluxes.

  14. Data-driven train set crash dynamics simulation

    NASA Astrophysics Data System (ADS)

    Tang, Zhao; Zhu, Yunrui; Nie, Yinyu; Guo, Shihui; Liu, Fengjia; Chang, Jian; Zhang, Jianjun

    2017-02-01

    Traditional finite element (FE) methods are arguably expensive in computation/simulation of the train crash. High computational cost limits their direct applications in investigating dynamic behaviours of an entire train set for crashworthiness design and structural optimisation. On the contrary, multi-body modelling is widely used because of its low computational cost with the trade-off in accuracy. In this study, a data-driven train crash modelling method is proposed to improve the performance of a multi-body dynamics simulation of train set crash without increasing the computational burden. This is achieved by the parallel random forest algorithm, which is a machine learning approach that extracts useful patterns of force-displacement curves and predicts a force-displacement relation in a given collision condition from a collection of offline FE simulation data on various collision conditions, namely different crash velocities in our analysis. Using the FE simulation results as a benchmark, we compared our method with traditional multi-body modelling methods and the result shows that our data-driven method improves the accuracy over traditional multi-body models in train crash simulation and runs at the same level of efficiency.

  15. Event-driven management algorithm of an Engineering documents circulation system

    NASA Astrophysics Data System (ADS)

    Kuzenkov, V.; Zebzeev, A.; Gromakov, E.

    2015-04-01

    Development methodology of an engineering documents circulation system in the design company is reviewed. Discrete event-driven automatic models using description algorithms of project management is offered. Petri net use for dynamic design of projects is offered.

  16. Event-Driven X-Ray CCD Detectors for High Energy Astrophysics

    NASA Technical Reports Server (NTRS)

    Ricker, George R.

    2004-01-01

    A viewgraph presentation describing the Event-Driven X- Ray CCD (EDCCD) detector system for high energy astrophysics is presented. The topics include: 1) EDCCD: Description and Advantages; 2) Summary of Grant Activity Carried Out; and 3) EDCCD Test System.

  17. Heinrich events modeled in transient glacial simulations

    NASA Astrophysics Data System (ADS)

    Ziemen, Florian; Kapsch, Marie; Mikolajewicz, Uwe

    2017-04-01

    Heinrich events are among the most prominent events of climate variability recorded in proxies across the northern hemisphere. They are the archetype of ice sheet — climate interactions on millennial time scales. Nevertheless, the exact mechanisms that cause Heinrich events are still under debate, and their climatic consequences are far from being fully understood. We address open questions by studying Heinrich events in a coupled ice sheet model (ISM) atmosphere-ocean-vegetation general circulation model (AOVGCM) framework, where this variability occurs as part of the model generated internal variability. The framework consists of a northern hemisphere setup of the modified Parallel Ice Sheet Model (mPISM) coupled to the global AOVGCM ECHAM5/MPIOM/LPJ. The simulations were performed fully coupled and with transient orbital and greenhouse gas forcing. They span from several millennia before the last glacial maximum into the deglaciation. To make these long simulations feasible, the atmosphere is accelerated by a factor of 10 relative to the other model components using a periodical-synchronous coupling technique. To disentangle effects of the Heinrich events and the deglaciation, we focus on the events occurring before the deglaciation. The modeled Heinrich events show a peak ice discharge of about 0.05 Sv and raise the sea level by 2.3 m on average. The resulting surface water freshening reduces the Atlantic meridional overturning circulation and ocean heat release. The reduction in ocean heat release causes a sub-surface warming and decreases the air temperature and precipitation regionally and downstream into Eurasia. The surface elevation decrease of the ice sheet enhances moisture transport onto the ice sheet and thus increases precipitation over the Hudson Bay area, thereby accelerating the recovery after an event.

  18. Predictive Sampling of Rare Conformational Events in Aqueous Solution: Designing a Generalized Orthogonal Space Tempering Method.

    PubMed

    Lu, Chao; Li, Xubin; Wu, Dongsheng; Zheng, Lianqing; Yang, Wei

    2016-01-12

    In aqueous solution, solute conformational transitions are governed by intimate interplays of the fluctuations of solute-solute, solute-water, and water-water interactions. To promote molecular fluctuations to enhance sampling of essential conformational changes, a common strategy is to construct an expanded Hamiltonian through a series of Hamiltonian perturbations and thereby broaden the distribution of certain interactions of focus. Due to a lack of active sampling of configuration response to Hamiltonian transitions, it is challenging for common expanded Hamiltonian methods to robustly explore solvent mediated rare conformational events. The orthogonal space sampling (OSS) scheme, as exemplified by the orthogonal space random walk and orthogonal space tempering methods, provides a general framework for synchronous acceleration of slow configuration responses. To more effectively sample conformational transitions in aqueous solution, in this work, we devised a generalized orthogonal space tempering (gOST) algorithm. Specifically, in the Hamiltonian perturbation part, a solvent-accessible-surface-area-dependent term is introduced to implicitly perturb near-solute water-water fluctuations; more importantly in the orthogonal space response part, the generalized force order parameter is generalized as a two-dimension order parameter set, in which essential solute-solvent and solute-solute components are separately treated. The gOST algorithm is evaluated through a molecular dynamics simulation study on the explicitly solvated deca-alanine (Ala10) peptide. On the basis of a fully automated sampling protocol, the gOST simulation enabled repetitive folding and unfolding of the solvated peptide within a single continuous trajectory and allowed for detailed constructions of Ala10 folding/unfolding free energy surfaces. The gOST result reveals that solvent cooperative fluctuations play a pivotal role in Ala10 folding/unfolding transitions. In addition, our assessment

  19. Flux-driven simulations of turbulence collapse

    DOE PAGES

    Park, G. Y.; Kim, S. S.; Jhang, Hogun; ...

    2015-03-12

    In this study, using self-consistent three-dimensional nonlinear simulations of tokamak turbulence, we show that an edge transport barrier (ETB) forms naturally due to mean E x B shear feedback through evolving pressure gradient once input power exceeds a threshold value. The temporal evolution and development of the transition are elucidated. Profiles, turbulence-driven flows and neoclassical coefficients are evolved self-consistently. A slow power ramp-up simulation shows that ETB transition is triggered by the turbulence-driven flows via an intermediate phase which involves coherent oscillation of turbulence intensity and E x B flow shear. A novel observation of the evolution is that themore » turbulence collapses and the ETB transition begins when R T > 1 at t = t R (R T : normalized Reynolds power), while the conventional transition criterion (ω E x B > γlin) is satisfied only after t = t C (> t R), when the mean ow shear grows due to positive feedback.« less

  20. Mass imbalances in EPANET water-quality simulations

    NASA Astrophysics Data System (ADS)

    Davis, Michael J.; Janke, Robert; Taxon, Thomas N.

    2018-04-01

    EPANET is widely employed to simulate water quality in water distribution systems. However, in general, the time-driven simulation approach used to determine concentrations of water-quality constituents provides accurate results only for short water-quality time steps. Overly long time steps can yield errors in concentration estimates and can result in situations in which constituent mass is not conserved. The use of a time step that is sufficiently short to avoid these problems may not always be feasible. The absence of EPANET errors or warnings does not ensure conservation of mass. This paper provides examples illustrating mass imbalances and explains how such imbalances can occur because of fundamental limitations in the water-quality routing algorithm used in EPANET. In general, these limitations cannot be overcome by the use of improved water-quality modeling practices. This paper also presents a preliminary event-driven approach that conserves mass with a water-quality time step that is as long as the hydraulic time step. Results obtained using the current approach converge, or tend to converge, toward those obtained using the preliminary event-driven approach as the water-quality time step decreases. Improving the water-quality routing algorithm used in EPANET could eliminate mass imbalances and related errors in estimated concentrations. The results presented in this paper should be of value to those who perform water-quality simulations using EPANET or use the results of such simulations, including utility managers and engineers.

  1. Parallel discrete event simulation using shared memory

    NASA Technical Reports Server (NTRS)

    Reed, Daniel A.; Malony, Allen D.; Mccredie, Bradley D.

    1988-01-01

    With traditional event-list techniques, evaluating a detailed discrete-event simulation-model can often require hours or even days of computation time. By eliminating the event list and maintaining only sufficient synchronization to ensure causality, parallel simulation can potentially provide speedups that are linear in the numbers of processors. A set of shared-memory experiments, using the Chandy-Misra distributed-simulation algorithm, to simulate networks of queues is presented. Parameters of the study include queueing network topology and routing probabilities, number of processors, and assignment of network nodes to processors. These experiments show that Chandy-Misra distributed simulation is a questionable alternative to sequential-simulation of most queueing network models.

  2. Anticipating the Chaotic Behaviour of Industrial Systems Based on Stochastic, Event-Driven Simulations

    NASA Astrophysics Data System (ADS)

    Bruzzone, Agostino G.; Revetria, Roberto; Simeoni, Simone; Viazzo, Simone; Orsoni, Alessandra

    2004-08-01

    In logistics and industrial production managers must deal with the impact of stochastic events to improve performances and reduce costs. In fact, production and logistics systems are generally designed considering some parameters as deterministically distributed. While this assumption is mostly used for preliminary prototyping, it is sometimes also retained during the final design stage, and especially for estimated parameters (i.e. Market Request). The proposed methodology can determine the impact of stochastic events in the system by evaluating the chaotic threshold level. Such an approach, based on the application of a new and innovative methodology, can be implemented to find the condition under which chaos makes the system become uncontrollable. Starting from problem identification and risk assessment, several classification techniques are used to carry out an effect analysis and contingency plan estimation. In this paper the authors illustrate the methodology with respect to a real industrial case: a production problem related to the logistics of distributed chemical processing.

  3. Database Driven 6-DOF Trajectory Simulation for Debris Transport Analysis

    NASA Technical Reports Server (NTRS)

    West, Jeff

    2008-01-01

    Debris mitigation and risk assessment have been carried out by NASA and its contractors supporting Space Shuttle Return-To-Flight (RTF). As a part of this assessment, analysis of transport potential for debris that may be liberated from the vehicle or from pad facilities prior to tower clear (Lift-Off Debris) is being performed by MSFC. This class of debris includes plume driven and wind driven sources for which lift as well as drag are critical for the determination of the debris trajectory. As a result, NASA MSFC has a need for a debris transport or trajectory simulation that supports the computation of lift effect in addition to drag without the computational expense of fully coupled CFD with 6-DOF. A database driven 6-DOF simulation that uses aerodynamic force and moment coefficients for the debris shape that are interpolated from a database has been developed to meet this need. The design, implementation, and verification of the database driven six degree of freedom (6-DOF) simulation addition to the Lift-Off Debris Transport Analysis (LODTA) software are discussed in this paper.

  4. Notification Event Architecture for Traveler Screening: Predictive Traveler Screening Using Event Driven Business Process Management

    ERIC Educational Resources Information Center

    Lynch, John Kenneth

    2013-01-01

    Using an exploratory model of the 9/11 terrorists, this research investigates the linkages between Event Driven Business Process Management (edBPM) and decision making. Although the literature on the role of technology in efficient and effective decision making is extensive, research has yet to quantify the benefit of using edBPM to aid the…

  5. Program For Simulation Of Trajectories And Events

    NASA Technical Reports Server (NTRS)

    Gottlieb, Robert G.

    1992-01-01

    Universal Simulation Executive (USE) program accelerates and eases generation of application programs for numerical simulation of continuous trajectories interrupted by or containing discrete events. Developed for simulation of multiple spacecraft trajectories with events as one spacecraft crossing the equator, two spacecraft meeting or parting, or firing rocket engine. USE also simulates operation of chemical batch processing factory. Written in Ada.

  6. Sequence-of-events-driven automation of the deep space network

    NASA Technical Reports Server (NTRS)

    Hill, R., Jr.; Fayyad, K.; Smyth, C.; Santos, T.; Chen, R.; Chien, S.; Bevan, R.

    1996-01-01

    In February 1995, sequence-of-events (SOE)-driven automation technology was demonstrated for a Voyager telemetry downlink track at DSS 13. This demonstration entailed automated generation of an operations procedure (in the form of a temporal dependency network) from project SOE information using artificial intelligence planning technology and automated execution of the temporal dependency network using the link monitor and control operator assistant system. This article describes the overall approach to SOE-driven automation that was demonstrated, identifies gaps in SOE definitions and project profiles that hamper automation, and provides detailed measurements of the knowledge engineering effort required for automation.

  7. Sequence-of-Events-Driven Automation of the Deep Space Network

    NASA Technical Reports Server (NTRS)

    Hill, R., Jr.; Fayyad, K.; Smyth, C.; Santos, T.; Chen, R.; Chien, S.; Bevan, R.

    1996-01-01

    In February 1995, sequence-of-events (SOE)-driven automation technology was demonstrated for a Voyager telemetry downlink track at DSS 13. This demonstration entailed automated generation of an operations procedure (in the form of a temporal dependency network) from project SOE information using artificial intelligence planning technology and automated execution of the temporal dependency network using the link monitor and control operator assistant system. This article describes the overall approach to SOE-driven automation that was demonstrated, identifies gaps in SOE definitions and project profiles that hamper automation, and provides detailed measurements of the knowledge engineering effort required for automation.

  8. A Framework for the Optimization of Discrete-Event Simulation Models

    NASA Technical Reports Server (NTRS)

    Joshi, B. D.; Unal, R.; White, N. H.; Morris, W. D.

    1996-01-01

    With the growing use of computer modeling and simulation, in all aspects of engineering, the scope of traditional optimization has to be extended to include simulation models. Some unique aspects have to be addressed while optimizing via stochastic simulation models. The optimization procedure has to explicitly account for the randomness inherent in the stochastic measures predicted by the model. This paper outlines a general purpose framework for optimization of terminating discrete-event simulation models. The methodology combines a chance constraint approach for problem formulation, together with standard statistical estimation and analyses techniques. The applicability of the optimization framework is illustrated by minimizing the operation and support resources of a launch vehicle, through a simulation model.

  9. Event-driven charge-coupled device design and applications therefor

    NASA Technical Reports Server (NTRS)

    Doty, John P. (Inventor); Ricker, Jr., George R. (Inventor); Burke, Barry E. (Inventor); Prigozhin, Gregory Y. (Inventor)

    2005-01-01

    An event-driven X-ray CCD imager device uses a floating-gate amplifier or other non-destructive readout device to non-destructively sense a charge level in a charge packet associated with a pixel. The output of the floating-gate amplifier is used to identify each pixel that has a charge level above a predetermined threshold. If the charge level is above a predetermined threshold the charge in the triggering charge packet and in the charge packets from neighboring pixels need to be measured accurately. A charge delay register is included in the event-driven X-ray CCD imager device to enable recovery of the charge packets from neighboring pixels for accurate measurement. When a charge packet reaches the end of the charge delay register, control logic either dumps the charge packet, or steers the charge packet to a charge FIFO to preserve it if the charge packet is determined to be a packet that needs accurate measurement. A floating-diffusion amplifier or other low-noise output stage device, which converts charge level to a voltage level with high precision, provides final measurement of the charge packets. The voltage level is eventually digitized by a high linearity ADC.

  10. Rare Event Simulation in Radiation Transport

    NASA Astrophysics Data System (ADS)

    Kollman, Craig

    This dissertation studies methods for estimating extremely small probabilities by Monte Carlo simulation. Problems in radiation transport typically involve estimating very rare events or the expected value of a random variable which is with overwhelming probability equal to zero. These problems often have high dimensional state spaces and irregular geometries so that analytic solutions are not possible. Monte Carlo simulation must be used to estimate the radiation dosage being transported to a particular location. If the area is well shielded the probability of any one particular particle getting through is very small. Because of the large number of particles involved, even a tiny fraction penetrating the shield may represent an unacceptable level of radiation. It therefore becomes critical to be able to accurately estimate this extremely small probability. Importance sampling is a well known technique for improving the efficiency of rare event calculations. Here, a new set of probabilities is used in the simulation runs. The results are multiplied by the likelihood ratio between the true and simulated probabilities so as to keep our estimator unbiased. The variance of the resulting estimator is very sensitive to which new set of transition probabilities are chosen. It is shown that a zero variance estimator does exist, but that its computation requires exact knowledge of the solution. A simple random walk with an associated killing model for the scatter of neutrons is introduced. Large deviation results for optimal importance sampling in random walks are extended to the case where killing is present. An adaptive "learning" algorithm for implementing importance sampling is given for more general Markov chain models of neutron scatter. For finite state spaces this algorithm is shown to give, with probability one, a sequence of estimates converging exponentially fast to the true solution. In the final chapter, an attempt to generalize this algorithm to a continuous

  11. Energetic storm particle events in coronal mass ejection-driven shocks

    NASA Astrophysics Data System (ADS)

    Mäkelä, P.; Gopalswamy, N.; Akiyama, S.; Xie, H.; Yashiro, S.

    2011-08-01

    We investigate the variability in the occurrence of energetic storm particle (ESP) events associated with shocks driven by coronal mass ejections (CMEs). The interplanetary shocks were detected during the period from 1996 to 2006. First, we analyze the CME properties near the Sun. The CMEs with an ESP-producing shock are faster ($\\langle$VCME$\\rangle$ = 1088 km/s) than those driving shocks without an ESP event ($\\langle$VCME$\\rangle$ = 771 km/s) and have a larger fraction of halo CMEs (67% versus 38%). The Alfvénic Mach numbers of shocks with an ESP event are on average 1.6 times higher than those of shocks without. We also contrast the ESP event properties and frequency in shocks with and without a type II radio burst by dividing the shocks into radio-loud (RL) and radio-quiet (RQ) shocks, respectively. The shocks seem to be organized into a decreasing sequence by the energy content of the CMEs: RL shocks with an ESP event are driven by the most energetic CMEs, followed by RL shocks without an ESP event, then RQ shocks with and without an ESP event. The ESP events occur more often in RL shocks than in RQ shocks: 52% of RL shocks and only ˜33% of RQ shocks produced an ESP event at proton energies above 1.8 MeV; in the keV energy range the ESP frequencies are 80% and 65%, respectively. Electron ESP events were detected in 19% of RQ shocks and 39% of RL shocks. In addition, we find that (1) ESP events in RQ shocks are less intense than those in RL shocks; (2) RQ shocks with ESP events are predominately quasi-perpendicular shocks; (3) their solar sources are located slightly to the east of the central meridian; and (4) ESP event sizes show a modest positive correlation with the CME and shock speeds. The observation that RL shocks tend to produce more frequently ESP events with larger particle flux increases than RQ shocks emphasizes the importance of type II bursts in identifying solar events prone to producing high particle fluxes in the near-Earth space

  12. ENSO effects on MLT diurnal tides: A 21 year reanalysis data-driven GAIA model simulation

    NASA Astrophysics Data System (ADS)

    Liu, Huixin; Sun, Yang-Yi; Miyoshi, Yasunobu; Jin, Hidekatsu

    2017-05-01

    Tidal responses to El Niño-Southern Oscillation (ENSO) in the mesosphere and lower thermosphere (MLT) are investigated for the first time using reanalysis data-driven simulations covering 21 years. The simulation is carried out with the Ground-to-topside Atmosphere-Ionosphere model for Aeronomy (GAIA) during 1996-2016, which covers nine ENSO events. ENSO impacts on diurnal tides at 100 km altitude are analyzed and cross-compared among temperature (T), zonal wind (U), and meridional wind (V), which reveals the following salient features: (1) Tidal response can differ significantly among T, U, and V in terms of magnitude and latitudinal structure, making detection of ENSO effects sensitive to the parameter used and the location of a ground station; (2) the nonmigrating DE3 tide in T and U shows a prominent hemisphere asymmetric response to La Niña, with an increase between 0° and 30°N and a decrease between 30° and 0°S. In contrast, DE3 in V exhibits no significant response; (3) the migrating DW1 enhances during El Niño in equatorial regions for T and U but in off-equatorial regions for V. As the first ENSO study based on reanalysis-driven simulations, GAIA's full set of tidal responses in T, U, and V provides us with a necessary global context to better understand and cross-compare observations during ENSO events. Comparisons with observations during the 1997-98 El Niño and 2010-11 La Niña reveal good agreement in both magnitude and timing. Comparisons with "free-run" WACCM simulations (T) show consistent results in nonmigrating tides DE2 and DE3 but differences in the migrating DW1 tide.

  13. Use case driven approach to develop simulation model for PCS of APR1400 simulator

    DOE Office of Scientific and Technical Information (OSTI.GOV)

    Dong Wook, Kim; Hong Soo, Kim; Hyeon Tae, Kang

    2006-07-01

    The full-scope simulator is being developed to evaluate specific design feature and to support the iterative design and validation in the Man-Machine Interface System (MMIS) design of Advanced Power Reactor (APR) 1400. The simulator consists of process model, control logic model, and MMI for the APR1400 as well as the Power Control System (PCS). In this paper, a use case driven approach is proposed to develop a simulation model for PCS. In this approach, a system is considered from the point of view of its users. User's view of the system is based on interactions with the system and themore » resultant responses. In use case driven approach, we initially consider the system as a black box and look at its interactions with the users. From these interactions, use cases of the system are identified. Then the system is modeled using these use cases as functions. Lower levels expand the functionalities of each of these use cases. Hence, starting from the topmost level view of the system, we proceeded down to the lowest level (the internal view of the system). The model of the system thus developed is use case driven. This paper will introduce the functionality of the PCS simulation model, including a requirement analysis based on use case and the validation result of development of PCS model. The PCS simulation model using use case will be first used during the full-scope simulator development for nuclear power plant and will be supplied to Shin-Kori 3 and 4 plant. The use case based simulation model development can be useful for the design and implementation of simulation models. (authors)« less

  14. A Simbol-X Event Simulator

    NASA Astrophysics Data System (ADS)

    Puccetti, S.; Fiore, F.; Giommi, P.

    2009-05-01

    The ASI Science Data Center (ASDC) has developed an X-ray event simulator to support users (and team members) in simulation of data taken with the two cameras on board the Simbol-X X-Ray Telescope. The Simbol-X simulator is very fast and flexible, compared to ray-tracing simulator. These properties make our simulator advantageous to support the user in planning proposals and comparing real data with the theoretical expectations and for a quick detection of unexpected features. We present here the simulator outline and a few examples of simulated data.

  15. Synchronous parallel system for emulation and discrete event simulation

    NASA Technical Reports Server (NTRS)

    Steinman, Jeffrey S. (Inventor)

    1992-01-01

    A synchronous parallel system for emulation and discrete event simulation having parallel nodes responds to received messages at each node by generating event objects having individual time stamps, stores only the changes to state variables of the simulation object attributable to the event object, and produces corresponding messages. The system refrains from transmitting the messages and changing the state variables while it determines whether the changes are superseded, and then stores the unchanged state variables in the event object for later restoral to the simulation object if called for. This determination preferably includes sensing the time stamp of each new event object and determining which new event object has the earliest time stamp as the local event horizon, determining the earliest local event horizon of the nodes as the global event horizon, and ignoring the events whose time stamps are less than the global event horizon. Host processing between the system and external terminals enables such a terminal to query, monitor, command or participate with a simulation object during the simulation process.

  16. Synchronous Parallel System for Emulation and Discrete Event Simulation

    NASA Technical Reports Server (NTRS)

    Steinman, Jeffrey S. (Inventor)

    2001-01-01

    A synchronous parallel system for emulation and discrete event simulation having parallel nodes responds to received messages at each node by generating event objects having individual time stamps, stores only the changes to the state variables of the simulation object attributable to the event object and produces corresponding messages. The system refrains from transmitting the messages and changing the state variables while it determines whether the changes are superseded, and then stores the unchanged state variables in the event object for later restoral to the simulation object if called for. This determination preferably includes sensing the time stamp of each new event object and determining which new event object has the earliest time stamp as the local event horizon, determining the earliest local event horizon of the nodes as the global event horizon, and ignoring events whose time stamps are less than the global event horizon. Host processing between the system and external terminals enables such a terminal to query, monitor, command or participate with a simulation object during the simulation process.

  17. Rare event simulation in radiation transport

    DOE Office of Scientific and Technical Information (OSTI.GOV)

    Kollman, Craig

    1993-10-01

    This dissertation studies methods for estimating extremely small probabilities by Monte Carlo simulation. Problems in radiation transport typically involve estimating very rare events or the expected value of a random variable which is with overwhelming probability equal to zero. These problems often have high dimensional state spaces and irregular geometries so that analytic solutions are not possible. Monte Carlo simulation must be used to estimate the radiation dosage being transported to a particular location. If the area is well shielded the probability of any one particular particle getting through is very small. Because of the large number of particles involved,more » even a tiny fraction penetrating the shield may represent an unacceptable level of radiation. It therefore becomes critical to be able to accurately estimate this extremely small probability. Importance sampling is a well known technique for improving the efficiency of rare event calculations. Here, a new set of probabilities is used in the simulation runs. The results are multiple by the likelihood ratio between the true and simulated probabilities so as to keep the estimator unbiased. The variance of the resulting estimator is very sensitive to which new set of transition probabilities are chosen. It is shown that a zero variance estimator does exist, but that its computation requires exact knowledge of the solution. A simple random walk with an associated killing model for the scatter of neutrons is introduced. Large deviation results for optimal importance sampling in random walks are extended to the case where killing is present. An adaptive ``learning`` algorithm for implementing importance sampling is given for more general Markov chain models of neutron scatter. For finite state spaces this algorithm is shown to give with probability one, a sequence of estimates converging exponentially fast to the true solution.« less

  18. Parallel discrete event simulation: A shared memory approach

    NASA Technical Reports Server (NTRS)

    Reed, Daniel A.; Malony, Allen D.; Mccredie, Bradley D.

    1987-01-01

    With traditional event list techniques, evaluating a detailed discrete event simulation model can often require hours or even days of computation time. Parallel simulation mimics the interacting servers and queues of a real system by assigning each simulated entity to a processor. By eliminating the event list and maintaining only sufficient synchronization to insure causality, parallel simulation can potentially provide speedups that are linear in the number of processors. A set of shared memory experiments is presented using the Chandy-Misra distributed simulation algorithm to simulate networks of queues. Parameters include queueing network topology and routing probabilities, number of processors, and assignment of network nodes to processors. These experiments show that Chandy-Misra distributed simulation is a questionable alternative to sequential simulation of most queueing network models.

  19. Event Driven Messaging with Role-Based Subscriptions

    NASA Technical Reports Server (NTRS)

    Bui, Tung; Bui, Bach; Malhotra, Shantanu; Chen, Fannie; Kim, rachel; Allen, Christopher; Luong, Ivy; Chang, George; Zendejas, Silvino; Sadaqathulla, Syed

    2009-01-01

    Event Driven Messaging with Role-Based Subscriptions (EDM-RBS) is a framework integrated into the Service Management Database (SMDB) to allow for role-based and subscription-based delivery of synchronous and asynchronous messages over JMS (Java Messaging Service), SMTP (Simple Mail Transfer Protocol), or SMS (Short Messaging Service). This allows for 24/7 operation with users in all parts of the world. The software classifies messages by triggering data type, application source, owner of data triggering event (mission), classification, sub-classification and various other secondary classifying tags. Messages are routed to applications or users based on subscription rules using a combination of the above message attributes. This program provides a framework for identifying connected users and their applications for targeted delivery of messages over JMS to the client applications the user is logged into. EDMRBS provides the ability to send notifications over e-mail or pager rather than having to rely on a live human to do it. It is implemented as an Oracle application that uses Oracle relational database management system intrinsic functions. It is configurable to use Oracle AQ JMS API or an external JMS provider for messaging. It fully integrates into the event-logging framework of SMDB (Subnet Management Database).

  20. A data-driven dynamics simulation framework for railway vehicles

    NASA Astrophysics Data System (ADS)

    Nie, Yinyu; Tang, Zhao; Liu, Fengjia; Chang, Jian; Zhang, Jianjun

    2018-03-01

    The finite element (FE) method is essential for simulating vehicle dynamics with fine details, especially for train crash simulations. However, factors such as the complexity of meshes and the distortion involved in a large deformation would undermine its calculation efficiency. An alternative method, the multi-body (MB) dynamics simulation provides satisfying time efficiency but limited accuracy when highly nonlinear dynamic process is involved. To maintain the advantages of both methods, this paper proposes a data-driven simulation framework for dynamics simulation of railway vehicles. This framework uses machine learning techniques to extract nonlinear features from training data generated by FE simulations so that specific mesh structures can be formulated by a surrogate element (or surrogate elements) to replace the original mechanical elements, and the dynamics simulation can be implemented by co-simulation with the surrogate element(s) embedded into a MB model. This framework consists of a series of techniques including data collection, feature extraction, training data sampling, surrogate element building, and model evaluation and selection. To verify the feasibility of this framework, we present two case studies, a vertical dynamics simulation and a longitudinal dynamics simulation, based on co-simulation with MATLAB/Simulink and Simpack, and a further comparison with a popular data-driven model (the Kriging model) is provided. The simulation result shows that using the legendre polynomial regression model in building surrogate elements can largely cut down the simulation time without sacrifice in accuracy.

  1. Wind driven general circulation of the Mediterranean Sea simulated with a Spectral Element Ocean Model

    NASA Astrophysics Data System (ADS)

    Molcard, A.; Pinardi, N.; Iskandarani, M.; Haidvogel, D. B.

    2002-05-01

    This work is an attempt to simulate the Mediterranean Sea general circulation with a Spectral Finite Element Model. This numerical technique associates the geometrical flexibility of the finite elements for the proper coastline definition with the precision offered by spectral methods. The model is reduced gravity and we study the wind-driven ocean response in order to explain the large scale sub-basin gyres and their variability. The study period goes from January 1987 to December 1993 and two forcing data sets are used. The effect of wind variability in space and time is analyzed and the relationship between wind stress curl and ocean response is stressed. Some of the main permanent structures of the general circulation (Gulf of Lions cyclonic gyre, Rhodes gyre, Gulf of Syrte anticylone) are shown to be induced by permanent wind stress curl structures. The magnitude and spatial variability of the wind is important in determining the appearance or disappearance of some gyres (Tyrrhenian anticyclonic gyre, Balearic anticyclonic gyre, Ionian cyclonic gyre). An EOF analysis of the seasonal variability indicates that the weakening and strengthening of the Levantine basin boundary currents is a major component of the seasonal cycle in the basin. The important discovery is that seasonal and interannual variability peak at the same spatial scales in the ocean response and that the interannual variability includes the change in amplitude and phase of the seasonal cycle in the sub-basin scale gyres and boundary currents. The Coriolis term in the vorticity balance seems to be responsible for the weakening of anticyclonic structures and their total disappearance when they are close to a boundary. The process of adjustment to winds produces a train of coastally trapped gravity waves which travel around the eastern and western basins, respectively in approximately 6 months. This corresponds to a phase velocity for the wave of about 1 m/s, comparable to an average velocity of

  2. Numerical simulation of plasma processes driven by transverse ion heating

    NASA Technical Reports Server (NTRS)

    Singh, Nagendra; Chan, C. B.

    1993-01-01

    The plasma processes driven by transverse ion heating in a diverging flux tube are investigated with numerical simulation. The heating is found to drive a host of plasma processes, in addition to the well-known phenomenon of ion conics. The downward electric field near the reverse shock generates a doublestreaming situation consisting of two upflowing ion populations with different average flow velocities. The electric field in the reverse shock region is modulated by the ion-ion instability driven by the multistreaming ions. The oscillating fields in this region have the possibility of heating electrons. These results from the simulations are compared with results from a previous study based on a hydrodynamical model. Effects of spatial resolutions provided by simulations on the evolution of the plasma are discussed.

  3. Hybrid Architectural Framework for C4ISR and Discrete-Event Simulation (DES) to Support Sensor-Driven Model Synthesis in Real-World Scenarios

    DTIC Science & Technology

    2013-09-01

    which utilizes FTA and then loads it into a DES engine to generate simulation results. .......44 Figure 21. This simulation architecture is...While Discrete Event Simulation ( DES ) can provide accurate time estimation and fast simulation speed, models utilizing it often suffer...C4ISR progress in MDW is developed in this research to demonstrate the feasibility of AEMF- DES and explore its potential. The simulation (MDSIM

  4. An experimental, theoretical and event-driven computational study of narrow vibrofluidised granular materials

    NASA Astrophysics Data System (ADS)

    Thornton, Anthony; Windows-Yule, Kit; Parker, David; Luding, Stefan

    2017-06-01

    We review simulations, experiments and a theoretical treatment of vertically vibrated granular media. The systems considered are confined in narrow quasi-two-dimensional and quasi-one-dimensional (column) geometries, where the vertical extension of the container is much larger than one or both horizontal lengths. The additional geometric constraint present in the column setup frustrates the convection state that is normally observed in wider geometries. We start by showing that the Event Driven (ED) simulation method is able to accurately reproduce the previously experimentally determined phase-diagram for vibrofludised granular materials. We then review two papers that used ED simulations to study narrow quasi-one-dimensional systems revealing a new phenomenon: collective oscillations of the grains with a characteristic frequency that is much lower than the frequency of energy injection. Theoretical work was then undertaken that is able to accurately predict the frequency of such an oscillation and Positron Emission Particle Tracking (PEPT) experiments were undertaken to provide the first experimental evidence of this new phenomenon. Finally, we briefly discuss ongoing work to create an open-source version of this ED via its integration in the existing open-source package MercuryDPM (http://MercuryDPM.org); which has many advanced features that are not found in other codes.

  5. Simulating Heinrich events in a coupled atmosphere-ocean-ice sheet model

    NASA Astrophysics Data System (ADS)

    Mikolajewicz, Uwe; Ziemen, Florian

    2016-04-01

    Heinrich events are among the most prominent events of long-term climate variability recorded in proxies across the northern hemisphere. They are the archetype of ice sheet - climate interactions on millennial time scales. Nevertheless, the exact mechanisms that cause Heinrich events are still under discussion, and their climatic consequences are far from being fully understood. We contribute to answering the open questions by studying Heinrich events in a coupled ice sheet model (ISM) atmosphere-ocean-vegetation general circulation model (AOVGCM) framework, where this variability occurs as part of the model generated internal variability without the need to prescribe external perturbations, as was the standard approach in almost all model studies so far. The setup consists of a northern hemisphere setup of the modified Parallel Ice Sheet Model (mPISM) coupled to the global coarse resolution AOVGCM ECHAM5/MPIOM/LPJ. The simulations used for this analysis were an ensemble covering substantial parts of the late Glacial forced with transient insolation and prescribed atmospheric greenhouse gas concentrations. The modeled Heinrich events show a marked influence of the ice discharge on the Atlantic circulation and heat transport, but none of the Heinrich events during the Glacial did show a complete collapse of the North Atlantic meridional overturning circulation. The simulated main consequences of the Heinrich events are a freshening and cooling over the North Atlantic and a drying over northern Europe.

  6. Desktop Modeling and Simulation: Parsimonious, yet Effective Discrete-Event Simulation Analysis

    NASA Technical Reports Server (NTRS)

    Bradley, James R.

    2012-01-01

    This paper evaluates how quickly students can be trained to construct useful discrete-event simulation models using Excel The typical supply chain used by many large national retailers is described, and an Excel-based simulation model is constructed of it The set of programming and simulation skills required for development of that model are then determined we conclude that six hours of training are required to teach the skills to MBA students . The simulation presented here contains all fundamental functionallty of a simulation model, and so our result holds for any discrete-event simulation model. We argue therefore that Industry workers with the same technical skill set as students having completed one year in an MBA program can be quickly trained to construct simulation models. This result gives credence to the efficacy of Desktop Modeling and Simulation whereby simulation analyses can be quickly developed, run, and analyzed with widely available software, namely Excel.

  7. Program For Parallel Discrete-Event Simulation

    NASA Technical Reports Server (NTRS)

    Beckman, Brian C.; Blume, Leo R.; Geiselman, John S.; Presley, Matthew T.; Wedel, John J., Jr.; Bellenot, Steven F.; Diloreto, Michael; Hontalas, Philip J.; Reiher, Peter L.; Weiland, Frederick P.

    1991-01-01

    User does not have to add any special logic to aid in synchronization. Time Warp Operating System (TWOS) computer program is special-purpose operating system designed to support parallel discrete-event simulation. Complete implementation of Time Warp mechanism. Supports only simulations and other computations designed for virtual time. Time Warp Simulator (TWSIM) subdirectory contains sequential simulation engine interface-compatible with TWOS. TWOS and TWSIM written in, and support simulations in, C programming language.

  8. Elucidating the electron transport in semiconductors via Monte Carlo simulations: an inquiry-driven learning path for engineering undergraduates

    NASA Astrophysics Data System (ADS)

    Persano Adorno, Dominique; Pizzolato, Nicola; Fazio, Claudio

    2015-09-01

    Within the context of higher education for science or engineering undergraduates, we present an inquiry-driven learning path aimed at developing a more meaningful conceptual understanding of the electron dynamics in semiconductors in the presence of applied electric fields. The electron transport in a nondegenerate n-type indium phosphide bulk semiconductor is modelled using a multivalley Monte Carlo approach. The main characteristics of the electron dynamics are explored under different values of the driving electric field, lattice temperature and impurity density. Simulation results are presented by following a question-driven path of exploration, starting from the validation of the model and moving up to reasoned inquiries about the observed characteristics of electron dynamics. Our inquiry-driven learning path, based on numerical simulations, represents a viable example of how to integrate a traditional lecture-based teaching approach with effective learning strategies, providing science or engineering undergraduates with practical opportunities to enhance their comprehension of the physics governing the electron dynamics in semiconductors. Finally, we present a general discussion about the advantages and disadvantages of using an inquiry-based teaching approach within a learning environment based on semiconductor simulations.

  9. On the performance of voltage stepping for the simulation of adaptive, nonlinear integrate-and-fire neuronal networks.

    PubMed

    Kaabi, Mohamed Ghaith; Tonnelier, Arnaud; Martinez, Dominique

    2011-05-01

    In traditional event-driven strategies, spike timings are analytically given or calculated with arbitrary precision (up to machine precision). Exact computation is possible only for simplified neuron models, mainly the leaky integrate-and-fire model. In a recent paper, Zheng, Tonnelier, and Martinez (2009) introduced an approximate event-driven strategy, named voltage stepping, that allows the generic simulation of nonlinear spiking neurons. Promising results were achieved in the simulation of single quadratic integrate-and-fire neurons. Here, we assess the performance of voltage stepping in network simulations by considering more complex neurons (quadratic integrate-and-fire neurons with adaptation) coupled with multiple synapses. To handle the discrete nature of synaptic interactions, we recast voltage stepping in a general framework, the discrete event system specification. The efficiency of the method is assessed through simulations and comparisons with a modified time-stepping scheme of the Runge-Kutta type. We demonstrated numerically that the original order of voltage stepping is preserved when simulating connected spiking neurons, independent of the network activity and connectivity.

  10. A 300-mV 220-nW event-driven ADC with real-time QRS detection for wearable ECG sensors.

    PubMed

    Zhang, Xiaoyang; Lian, Yong

    2014-12-01

    This paper presents an ultra-low-power event-driven analog-to-digital converter (ADC) with real-time QRS detection for wearable electrocardiogram (ECG) sensors in wireless body sensor network (WBSN) applications. Two QRS detection algorithms, pulse-triggered (PUT) and time-assisted PUT (t-PUT), are proposed based on the level-crossing events generated from the ADC. The PUT detector achieves 97.63% sensitivity and 97.33% positive prediction in simulation on the MIT-BIH Arrhythmia Database. The t-PUT improves the sensitivity and positive prediction to 97.76% and 98.59% respectively. Fabricated in 0.13 μm CMOS technology, the ADC with QRS detector consumes only 220 nW measured under 300 mV power supply, making it the first nanoWatt compact analog-to-information (A2I) converter with embedded QRS detector.

  11. Water Hammer Simulations of MMH Propellant - New Capability Demonstration of the Generalized Fluid Flow Simulation Program

    NASA Technical Reports Server (NTRS)

    Burkhardt, Z.; Ramachandran, N.; Majumdar, A.

    2017-01-01

    Fluid Transient analysis is important for the design of spacecraft propulsion system to ensure structural stability of the system in the event of sudden closing or opening of the valve. Generalized Fluid System Simulation Program (GFSSP), a general purpose flow network code developed at NASA/MSFC is capable of simulating pressure surge due to sudden opening or closing of valve when thermodynamic properties of real fluid are available for the entire range of simulation. Specifically GFSSP needs an accurate representation of pressure-density relationship in order to predict pressure surge during a fluid transient. Unfortunately, the available thermodynamic property programs such as REFPROP, GASP or GASPAK does not provide the thermodynamic properties of Monomethylhydrazine (MMH). This paper will illustrate the process used for building a customized table of properties of state variables from available properties and speed of sound that is required by GFSSP for simulation. Good agreement was found between the simulations and measured data. This method can be adopted for modeling flow networks and systems with other fluids whose properties are not known in detail in order to obtain general technical insight. Rigorous code validation of this approach will be done and reported at a future date.

  12. An Advanced Simulation Framework for Parallel Discrete-Event Simulation

    NASA Technical Reports Server (NTRS)

    Li, P. P.; Tyrrell, R. Yeung D.; Adhami, N.; Li, T.; Henry, H.

    1994-01-01

    Discrete-event simulation (DEVS) users have long been faced with a three-way trade-off of balancing execution time, model fidelity, and number of objects simulated. Because of the limits of computer processing power the analyst is often forced to settle for less than desired performances in one or more of these areas.

  13. Synchrony between reanalysis-driven RCM simulations and observations: variation with time scale

    NASA Astrophysics Data System (ADS)

    de Elía, Ramón; Laprise, René; Biner, Sébastien; Merleau, James

    2017-04-01

    Unlike coupled global climate models (CGCMs) that run in a stand-alone mode, nested regional climate models (RCMs) are driven by either a CGCM or a reanalysis dataset. This feature makes high correlations between the RCM simulation and its driver possible. When the driving dataset is a reanalysis, time correlations between RCM output and observations are also common and to be expected. In certain situations time correlation between driver and driven RCM is of particular interest and techniques have been developed to increase it (e.g. large-scale spectral nudging). For such cases, a question that remains open is whether aggregating in time increases the correlation between RCM output and observations. That is, although the RCM may be unable to reproduce a given daily event, whether it will still be able to satisfactorily simulate an anomaly on a monthly or annual basis. This is a preconception that the authors of this work and others in the community have held, perhaps as a natural extension of the properties of upscaling or aggregating other statistics such as the mean squared error. Here we explore analytically four particular cases that help us partially answer this question. In addition, we use observations datasets and RCM-simulated data to illustrate our findings. Results indicate that time upscaling does not necessarily increase time correlations, and that those interested in achieving high monthly or annual time correlations between RCM output and observations may have to do so by increasing correlation as much as possible at the shortest time scale. This may indicate that even when only concerned with time correlations at large temporal scale, large-scale spectral nudging acting at the time-step level may have to be used.

  14. On the Role of Ionospheric Ions in Sawtooth Events

    NASA Astrophysics Data System (ADS)

    Lund, E. J.; Nowrouzi, N.; Kistler, L. M.; Cai, X.; Frey, H. U.

    2016-12-01

    Global multifluid simulations have suggested that ions of ionospheric origin play a key role in driving sawtooth events, particularly events driven by coronal mass ejections (CMEs), through a feedback mechanism.1,2 The energy input from the first substorm causes ion outflow, which is claimed to drive the next substorm. We show that in situ data from Cluster in the tail during sawtooth events do not support this hypothesis. We show two detailed event studies, one driven by a CME and one driven by a streaming interaction region (SIR), as well as a statistical survey of all sawtooth events for which Cluster tail data are available. While examples exist of nightside outflow reaching the mid-tail ( 19 RE) region during CME-driven events, the overwhelming majority of both CME-driven and SIR-driven sawtooth injections have ionospheric ions in this region originating from the cusp, where the outflow is predominantly directly driven by the solar wind. The 19 RE region is critical because that is the region where near-Earth neutral line reconnection occurs. We conclude that while ionospheric outflow may contribute to sawtooth events, the injections are not the result of a feedback between the tail and the ionosphere. 1O. J. Brambles et al. (2011), Science 332, 1183, doi:10.1126/science.1202869.2O. J. Brambles et al. (2013), JGR 118, 6026, doi:10.1002/jgra.50522.

  15. Sampled-data consensus in switching networks of integrators based on edge events

    NASA Astrophysics Data System (ADS)

    Xiao, Feng; Meng, Xiangyu; Chen, Tongwen

    2015-02-01

    This paper investigates the event-driven sampled-data consensus in switching networks of multiple integrators and studies both the bidirectional interaction and leader-following passive reaction topologies in a unified framework. In these topologies, each information link is modelled by an edge of the information graph and assigned a sequence of edge events, which activate the mutual data sampling and controller updates of the two linked agents. Two kinds of edge-event-detecting rules are proposed for the general asynchronous data-sampling case and the synchronous periodic event-detecting case. They are implemented in a distributed fashion, and their effectiveness in reducing communication costs and solving consensus problems under a jointly connected topology condition is shown by both theoretical analysis and simulation examples.

  16. USMC Inventory Control Using Optimization Modeling and Discrete Event Simulation

    DTIC Science & Technology

    2016-09-01

    release. Distribution is unlimited. USMC INVENTORY CONTROL USING OPTIMIZATION MODELING AND DISCRETE EVENT SIMULATION by Timothy A. Curling...USING OPTIMIZATION MODELING AND DISCRETE EVENT SIMULATION 5. FUNDING NUMBERS 6. AUTHOR(S) Timothy A. Curling 7. PERFORMING ORGANIZATION NAME(S...optimization and discrete -event simulation. This construct can potentially provide an effective means in improving order management decisions. However

  17. Generalized event knowledge activation during online sentence comprehension

    PubMed Central

    Metusalem, Ross; Kutas, Marta; Urbach, Thomas P.; Hare, Mary; McRae, Ken; Elman, Jeffrey L.

    2012-01-01

    Recent research has demonstrated that knowledge of real-world eventsplays an important role inguiding online language comprehension. The present study addresses the scope of event knowledge activation during the course of comprehension, specifically investigating whether activation is limited to those knowledge elements that align with the local linguistic context.The present study addresses this issue by analyzing event-related brain potentials (ERPs) recorded as participants read brief scenariosdescribing typical real-world events. Experiment 1 demonstratesthat a contextually anomalous word elicits a reduced N400 if it is generally related to the described event, even when controlling for the degree of association of this word with individual words in the preceding context and with the expected continuation. Experiment 2 shows that this effect disappears when the discourse context is removed.These findings demonstrate that during the course of incremental comprehension, comprehenders activate general knowledge about the described event, even at points at which this knowledge would constitute an anomalous continuation of the linguistic stream. Generalized event knowledge activationcontributes to mental representations of described events, is immediately available to influence language processing, and likely drives linguistic expectancy generation. PMID:22711976

  18. Event-driven processing for hardware-efficient neural spike sorting

    NASA Astrophysics Data System (ADS)

    Liu, Yan; Pereira, João L.; Constandinou, Timothy G.

    2018-02-01

    Objective. The prospect of real-time and on-node spike sorting provides a genuine opportunity to push the envelope of large-scale integrated neural recording systems. In such systems the hardware resources, power requirements and data bandwidth increase linearly with channel count. Event-based (or data-driven) processing can provide here a new efficient means for hardware implementation that is completely activity dependant. In this work, we investigate using continuous-time level-crossing sampling for efficient data representation and subsequent spike processing. Approach. (1) We first compare signals (synthetic neural datasets) encoded with this technique against conventional sampling. (2) We then show how such a representation can be directly exploited by extracting simple time domain features from the bitstream to perform neural spike sorting. (3) The proposed method is implemented in a low power FPGA platform to demonstrate its hardware viability. Main results. It is observed that considerably lower data rates are achievable when using 7 bits or less to represent the signals, whilst maintaining the signal fidelity. Results obtained using both MATLAB and reconfigurable logic hardware (FPGA) indicate that feature extraction and spike sorting accuracies can be achieved with comparable or better accuracy than reference methods whilst also requiring relatively low hardware resources. Significance. By effectively exploiting continuous-time data representation, neural signal processing can be achieved in a completely event-driven manner, reducing both the required resources (memory, complexity) and computations (operations). This will see future large-scale neural systems integrating on-node processing in real-time hardware.

  19. The power of event-driven analytics in Large Scale Data Processing

    DOE Office of Scientific and Technical Information (OSTI.GOV)

    Sebastiao, Nuno; Marques, Paulo

    2011-02-24

    FeedZai is a software company specialized in creating high-­‐throughput low-­‐latency data processing solutions. FeedZai develops a product called "FeedZai Pulse" for continuous event-­‐driven analytics that makes application development easier for end users. It automatically calculates key performance indicators and baselines, showing how current performance differ from previous history, creating timely business intelligence updated to the second. The tool does predictive analytics and trend analysis, displaying data on real-­‐time web-­‐based graphics. In 2010 FeedZai won the European EBN Smart Entrepreneurship Competition, in the Digital Models category, being considered one of the "top-­‐20 smart companies in Europe". The main objective of thismore » seminar/workshop is to explore the topic for large-­‐scale data processing using Complex Event Processing and, in particular, the possible uses of Pulse in the scope of the data processing needs of CERN. Pulse is available as open-­‐source and can be licensed both for non-­‐commercial and commercial applications. FeedZai is interested in exploring possible synergies with CERN in high-­‐volume low-­‐latency data processing applications. The seminar will be structured in two sessions, the first one being aimed to expose the general scope of FeedZai's activities, and the second focused on Pulse itself: 10:00-11:00 FeedZai and Large Scale Data Processing; Introduction to FeedZai; FeedZai Pulse and Complex Event Processing; Demonstration; Use-Cases and Applications; Conclusion and Q&A. 11:00-11:15 Coffee break 11:15-12:30 FeedZai Pulse Under the Hood; A First FeedZai Pulse Application; PulseQL overview; Defining KPIs and Baselines; Conclusion and Q&A. About the speakers Nuno Sebastião is the CEO of FeedZai. Having worked for many years for the European Space Agency (ESA), he was responsible the overall design and development of Satellite Simulation Infrastructure of the agency. Having

  20. The power of event-driven analytics in Large Scale Data Processing

    ScienceCinema

    None

    2017-12-09

    FeedZai is a software company specialized in creating high-­-throughput low-­-latency data processing solutions. FeedZai develops a product called "FeedZai Pulse" for continuous event-­-driven analytics that makes application development easier for end users. It automatically calculates key performance indicators and baselines, showing how current performance differ from previous history, creating timely business intelligence updated to the second. The tool does predictive analytics and trend analysis, displaying data on real-­-time web-­-based graphics. In 2010 FeedZai won the European EBN Smart Entrepreneurship Competition, in the Digital Models category, being considered one of the "top-­-20 smart companies in Europe". The main objective of this seminar/workshop is to explore the topic for large-­-scale data processing using Complex Event Processing and, in particular, the possible uses of Pulse in the scope of the data processing needs of CERN. Pulse is available as open-­-source and can be licensed both for non-­-commercial and commercial applications. FeedZai is interested in exploring possible synergies with CERN in high-­-volume low-­-latency data processing applications. The seminar will be structured in two sessions, the first one being aimed to expose the general scope of FeedZai's activities, and the second focused on Pulse itself: 10:00-11:00 FeedZai and Large Scale Data Processing Introduction to FeedZai FeedZai Pulse and Complex Event Processing Demonstration Use-Cases and Applications Conclusion and Q&A 11:00-11:15 Coffee break 11:15-12:30 FeedZai Pulse Under the Hood A First FeedZai Pulse Application PulseQL overview Defining KPIs and Baselines Conclusion and Q&A About the speakers Nuno Sebastião is the CEO of FeedZai. Having worked for many years for the European Space Agency (ESA), he was responsible the overall design and development of Satellite Simulation Infrastructure of the agency. Having left ESA to found FeedZai, Nuno is

  1. Discretely Integrated Condition Event (DICE) Simulation for Pharmacoeconomics.

    PubMed

    Caro, J Jaime

    2016-07-01

    Several decision-analytic modeling techniques are in use for pharmacoeconomic analyses. Discretely integrated condition event (DICE) simulation is proposed as a unifying approach that has been deliberately designed to meet the modeling requirements in a straightforward transparent way, without forcing assumptions (e.g., only one transition per cycle) or unnecessary complexity. At the core of DICE are conditions that represent aspects that persist over time. They have levels that can change and many may coexist. Events reflect instantaneous occurrences that may modify some conditions or the timing of other events. The conditions are discretely integrated with events by updating their levels at those times. Profiles of determinant values allow for differences among patients in the predictors of the disease course. Any number of valuations (e.g., utility, cost, willingness-to-pay) of conditions and events can be applied concurrently in a single run. A DICE model is conveniently specified in a series of tables that follow a consistent format and the simulation can be implemented fully in MS Excel, facilitating review and validation. DICE incorporates both state-transition (Markov) models and non-resource-constrained discrete event simulation in a single formulation; it can be executed as a cohort or a microsimulation; and deterministically or stochastically.

  2. Predicting analysis time in events-driven clinical trials using accumulating time-to-event surrogate information.

    PubMed

    Wang, Jianming; Ke, Chunlei; Yu, Zhinuan; Fu, Lei; Dornseif, Bruce

    2016-05-01

    For clinical trials with time-to-event endpoints, predicting the accrual of the events of interest with precision is critical in determining the timing of interim and final analyses. For example, overall survival (OS) is often chosen as the primary efficacy endpoint in oncology studies, with planned interim and final analyses at a pre-specified number of deaths. Often, correlated surrogate information, such as time-to-progression (TTP) and progression-free survival, are also collected as secondary efficacy endpoints. It would be appealing to borrow strength from the surrogate information to improve the precision of the analysis time prediction. Currently available methods in the literature for predicting analysis timings do not consider utilizing the surrogate information. In this article, using OS and TTP as an example, a general parametric model for OS and TTP is proposed, with the assumption that disease progression could change the course of the overall survival. Progression-free survival, related both to OS and TTP, will be handled separately, as it can be derived from OS and TTP. The authors seek to develop a prediction procedure using a Bayesian method and provide detailed implementation strategies under certain assumptions. Simulations are performed to evaluate the performance of the proposed method. An application to a real study is also provided. Copyright © 2015 John Wiley & Sons, Ltd. Copyright © 2015 John Wiley & Sons, Ltd.

  3. Study of Plasma Liner Driven Magnetized Target Fusion Via Advanced Simulations

    DOE Office of Scientific and Technical Information (OSTI.GOV)

    Samulyak, Roman V.; Brookhaven National Lab.; Parks, Paul

    The feasibility of the plasma liner driven Magnetized Target Fusion (MTF) via terascale numerical simulations will be assessed. In the MTF concept, a plasma liner, formed by merging of a number (60 or more) of radial, highly supersonic plasma jets, implodes on the target in the form of two compact plasma toroids, and compresses it to conditions of the fusion ignition. By avoiding major difficulties associated with both the traditional laser driven inertial confinement fusion and solid liner driven MTF, the plasma liner driven MTF potentially provides a low-cost and fast R&D path towards the demonstration of practical fusion energy.more » High fidelity numerical simulations of full nonlinear models associated with the plasma liner MTF using state-of-art numerical algorithms and terascale computing are necessary in order to resolve uncertainties and provide guidance for future experiments. At Stony Brook University, we have developed unique computational capabilities that ideally suite the MTF problem. The FronTier code, developed in collaboration with BNL and LANL under DOE funding including SciDAC for the simulation of 3D multi-material hydro and MHD flows, has beenbenchmarked and used for fundamental and engineering problems in energy science applications. We have performed 3D simulations of converging supersonic plasma jets, their merger and the formation of the plasma liner, and a study of the corresponding oblique shock problem. We have studied the implosion of the plasma liner on the magnetized plasma target by resolving Rayleigh-Taylor instabilities in 2D and 3D and other relevant physics and estimate thermodynamic conditions of the target at the moment of maximum compression and the hydrodynamic efficiency of the method.« less

  4. Manual for the Jet Event and Background Simulation Library

    DOE Office of Scientific and Technical Information (OSTI.GOV)

    Heinz, M.; Soltz, R.; Angerami, A.

    Jets are the collimated streams of particles resulting from hard scattering in the initial state of high-energy collisions. In heavy-ion collisions, jets interact with the quark-gluon plasma (QGP) before freezeout, providing a probe into the internal structure and properties of the QGP. In order to study jets, background must be subtracted from the measured event, potentially introducing a bias. We aim to understand and quantify this subtraction bias. PYTHIA, a library to simulate pure jet events, is used to simulate a model for a signature with one pure jet (a photon) and one quenched jet, where all quenched particle momentamore » are reduced by a user-de ned constant fraction. Background for the event is simulated using multiplicity values generated by the TRENTO initial state model of heavy-ion collisions fed into a thermal model consisting of a 3-dimensional Boltzmann distribution for particle types and momenta. Data from the simulated events is used to train a statistical model, which computes a posterior distribution of the quench factor for a data set. The model was tested rst on pure jet events and then on full events including the background. This model will allow for a quantitative determination of biases induced by various methods of background subtraction.« less

  5. Good vibrations: tactile feedback in support of attention allocation and human-automation coordination in event-driven domains.

    PubMed

    Sklar, A E; Sarter, N B

    1999-12-01

    Observed breakdowns in human-machine communication can be explained, in part, by the nature of current automation feedback, which relies heavily on focal visual attention. Such feedback is not well suited for capturing attention in case of unexpected changes and events or for supporting the parallel processing of large amounts of data in complex domains. As suggested by multiple-resource theory, one possible solution to this problem is to distribute information across various sensory modalities. A simulator study was conducted to compare the effectiveness of visual, tactile, and redundant visual and tactile cues for indicating unexpected changes in the status of an automated cockpit system. Both tactile conditions resulted in higher detection rates for, and faster response times to, uncommanded mode transitions. Tactile feedback did not interfere with, nor was its effectiveness affected by, the performance of concurrent visual tasks. The observed improvement in task-sharing performance indicates that the introduction of tactile feedback is a promising avenue toward better supporting human-machine communication in event-driven, information-rich domains.

  6. Data-driven parameterization of the generalized Langevin equation

    DOE PAGES

    Lei, Huan; Baker, Nathan A.; Li, Xiantao

    2016-11-29

    We present a data-driven approach to determine the memory kernel and random noise of the generalized Langevin equation. To facilitate practical implementations, we parameterize the kernel function in the Laplace domain by a rational function, with coefficients directly linked to the equilibrium statistics of the coarse-grain variables. Further, we show that such an approximation can be constructed to arbitrarily high order. Within these approximations, the generalized Langevin dynamics can be embedded in an extended stochastic model without memory. We demonstrate how to introduce the stochastic noise so that the fluctuation-dissipation theorem is exactly satisfied.

  7. Data Albums: An Event Driven Search, Aggregation and Curation Tool for Earth Science

    NASA Technical Reports Server (NTRS)

    Ramachandran, Rahul; Kulkarni, Ajinkya; Maskey, Manil; Bakare, Rohan; Basyal, Sabin; Li, Xiang; Flynn, Shannon

    2014-01-01

    One of the largest continuing challenges in any Earth science investigation is the discovery and access of useful science content from the increasingly large volumes of Earth science data and related information available. Approaches used in Earth science research such as case study analysis and climatology studies involve gathering discovering and gathering diverse data sets and information to support the research goals. Research based on case studies involves a detailed description of specific weather events using data from different sources, to characterize physical processes in play for a specific event. Climatology-based research tends to focus on the representativeness of a given event, by studying the characteristics and distribution of a large number of events. This allows researchers to generalize characteristics such as spatio-temporal distribution, intensity, annual cycle, duration, etc. To gather relevant data and information for case studies and climatology analysis is both tedious and time consuming. Current Earth science data systems are designed with the assumption that researchers access data primarily by instrument or geophysical parameter. Those who know exactly the datasets of interest can obtain the specific files they need using these systems. However, in cases where researchers are interested in studying a significant event, they have to manually assemble a variety of datasets relevant to it by searching the different distributed data systems. In these cases, a search process needs to be organized around the event rather than observing instruments. In addition, the existing data systems assume users have sufficient knowledge regarding the domain vocabulary to be able to effectively utilize their catalogs. These systems do not support new or interdisciplinary researchers who may be unfamiliar with the domain terminology. This paper presents a specialized search, aggregation and curation tool for Earth science to address these existing

  8. Event-Driven Process Chains (EPC)

    NASA Astrophysics Data System (ADS)

    Mendling, Jan

    This chapter provides a comprehensive overview of Event-driven Process Chains (EPCs) and introduces a novel definition of EPC semantics. EPCs became popular in the 1990s as a conceptual business process modeling language in the context of reference modeling. Reference modeling refers to the documentation of generic business operations in a model such as service processes in the telecommunications sector, for example. It is claimed that reference models can be reused and adapted as best-practice recommendations in individual companies (see [230, 168, 229, 131, 400, 401, 446, 127, 362, 126]). The roots of reference modeling can be traced back to the Kölner Integrationsmodell (KIM) [146, 147] that was developed in the 1960s and 1970s. In the 1990s, the Institute of Information Systems (IWi) in Saarbrücken worked on a project with SAP to define a suitable business process modeling language to document the processes of the SAP R/3 enterprise resource planning system. There were two results from this joint effort: the definition of EPCs [210] and the documentation of the SAP system in the SAP Reference Model (see [92, 211]). The extensive database of this reference model contains almost 10,000 sub-models: 604 of them non-trivial EPC business process models. The SAP Reference model had a huge impact with several researchers referring to it in their publications (see [473, 235, 127, 362, 281, 427, 415]) as well as motivating the creation of EPC reference models in further domains including computer integrated manufacturing [377, 379], logistics [229] or retail [52]. The wide-spread application of EPCs in business process modeling theory and practice is supported by their coverage in seminal text books for business process management and information systems in general (see [378, 380, 49, 384, 167, 240]). EPCs are frequently used in practice due to a high user acceptance [376] and extensive tool support. Some examples of tools that support EPCs are ARIS Toolset by IDS

  9. Simulation of EAST vertical displacement events by tokamak simulation code

    NASA Astrophysics Data System (ADS)

    Qiu, Qinglai; Xiao, Bingjia; Guo, Yong; Liu, Lei; Xing, Zhe; Humphreys, D. A.

    2016-10-01

    Vertical instability is a potentially serious hazard for elongated plasma. In this paper, the tokamak simulation code (TSC) is used to simulate vertical displacement events (VDE) on the experimental advanced superconducting tokamak (EAST). Key parameters from simulations, including plasma current, plasma shape and position, flux contours and magnetic measurements match experimental data well. The growth rates simulated by TSC are in good agreement with TokSys results. In addition to modeling the free drift, an EAST fast vertical control model enables TSC to simulate the course of VDE recovery. The trajectories of the plasma current center and control currents on internal coils (IC) fit experimental data well.

  10. Event-Driven Random-Access-Windowing CCD Imaging System

    NASA Technical Reports Server (NTRS)

    Monacos, Steve; Portillo, Angel; Ortiz, Gerardo; Alexander, James; Lam, Raymond; Liu, William

    2004-01-01

    A charge-coupled-device (CCD) based high-speed imaging system, called a realtime, event-driven (RARE) camera, is undergoing development. This camera is capable of readout from multiple subwindows [also known as regions of interest (ROIs)] within the CCD field of view. Both the sizes and the locations of the ROIs can be controlled in real time and can be changed at the camera frame rate. The predecessor of this camera was described in High-Frame-Rate CCD Camera Having Subwindow Capability (NPO- 30564) NASA Tech Briefs, Vol. 26, No. 12 (December 2002), page 26. The architecture of the prior camera requires tight coupling between camera control logic and an external host computer that provides commands for camera operation and processes pixels from the camera. This tight coupling limits the attainable frame rate and functionality of the camera. The design of the present camera loosens this coupling to increase the achievable frame rate and functionality. From a host computer perspective, the readout operation in the prior camera was defined on a per-line basis; in this camera, it is defined on a per-ROI basis. In addition, the camera includes internal timing circuitry. This combination of features enables real-time, event-driven operation for adaptive control of the camera. Hence, this camera is well suited for applications requiring autonomous control of multiple ROIs to track multiple targets moving throughout the CCD field of view. Additionally, by eliminating the need for control intervention by the host computer during the pixel readout, the present design reduces ROI-readout times to attain higher frame rates. This camera (see figure) includes an imager card consisting of a commercial CCD imager and two signal-processor chips. The imager card converts transistor/ transistor-logic (TTL)-level signals from a field programmable gate array (FPGA) controller card. These signals are transmitted to the imager card via a low-voltage differential signaling (LVDS) cable

  11. Tidally driven pore water exchange within offshore intertidal sandbanks: Part II numerical simulations

    NASA Astrophysics Data System (ADS)

    Gibbes, B.; Robinson, C.; Li, L.; Lockington, D.; Li, H.

    2008-12-01

    Field measurements presented by [Gibbes, B., Robinson, C., Li, L., Lockington, D.A., Carey, H., 2008. Tidally driven pore water exchange within offshore intertidal sandbanks: Part I Field measurements. Estuarine, Coastal and Shelf Science 79, pp. 121-132.] revealed a tidally driven pore water flow system within an offshore intertidal sandbank in Moreton Bay, Australia. The field data suggested that this flow system might be capable of delivering nutrients, and in particular bio-available iron, across the sediment-water interface. Bio-available iron has been implicated as a key nutrient in the growth of the toxic marine cyanobacteria Lyngbya majuscula and therefore this pore water exchange process is of interest at sites where L. majuscula blooms have been observed. In this study two-dimensional numerical simulations were used in conjunction with hydraulic data from field measurements to further investigate the tidally induced pore water flow patterns. Simulation results generally showed good agreement with the field data and revealed a more complex residual pore water flow system in the sandbank than shown by the field data. The flow system, strongly influenced by the geometry of the sandbank, was characterized by two circulation cells which resulted in pore water discharge at the bank edge and also to a permanently ponded area within the sandbank interior. Simulated discharge volumes in these two zones were in the order of 0.813 m 3 and 0.143 m 3 per meter width (along shore) of sandbank per tidal cycle at the bank edge and sandbank interior respectively. Transit times of pore water circulating through these cells were found to range from ≈ 17 days to > 60 years with an average time of 780 days. The results suggest that the tidally driven flow systems might provide a mechanism for transport of bio-available iron across the sediment-water interface. This flow could constitute a previously unrecognized source of bio-available iron for L. majuscula blooms in the

  12. An Empirical Development of Parallelization Guidelines for Time-Driven Simulation

    DTIC Science & Technology

    1989-12-01

    wives, who though not Cub fans, put on a good show during our trip, to waich some games . I would also like to recognize the help of my professors at...program parallelization. in this research effort a Ballistic Missile Defense (BMD) time driven simulation program, developed by DESE Research and...continuously, or continuously with discrete changes superimposed. The distinguishing feature of these simulations is the interaction between discretely

  13. Temporal integration: intentional sound discrimination does not modulate stimulus-driven processes in auditory event synthesis.

    PubMed

    Sussman, Elyse; Winkler, István; Kreuzer, Judith; Saher, Marieke; Näätänen, Risto; Ritter, Walter

    2002-12-01

    Our previous study showed that the auditory context could influence whether two successive acoustic changes occurring within the temporal integration window (approximately 200ms) were pre-attentively encoded as a single auditory event or as two discrete events (Cogn Brain Res 12 (2001) 431). The aim of the current study was to assess whether top-down processes could influence the stimulus-driven processes in determining what constitutes an auditory event. Electroencepholagram (EEG) was recorded from 11 scalp electrodes to frequently occurring standard and infrequently occurring deviant sounds. Within the stimulus blocks, deviants either occurred only in pairs (successive feature changes) or both singly and in pairs. Event-related potential indices of change and target detection, the mismatch negativity (MMN) and the N2b component, respectively, were compared with the simultaneously measured performance in discriminating the deviants. Even though subjects could voluntarily distinguish the two successive auditory feature changes from each other, which was also indicated by the elicitation of the N2b target-detection response, top-down processes did not modify the event organization reflected by the MMN response. Top-down processes can extract elemental auditory information from a single integrated acoustic event, but the extraction occurs at a later processing stage than the one whose outcome is indexed by MMN. Initial processes of auditory event-formation are fully governed by the context within which the sounds occur. Perception of the deviants as two separate sound events (the top-down effects) did not change the initial neural representation of the same deviants as one event (indexed by the MMN), without a corresponding change in the stimulus-driven sound organization.

  14. General-relativistic Large-eddy Simulations of Binary Neutron Star Mergers

    DOE Office of Scientific and Technical Information (OSTI.GOV)

    Radice, David, E-mail: dradice@astro.princeton.edu

    The flow inside remnants of binary neutron star (NS) mergers is expected to be turbulent, because of magnetohydrodynamics instability activated at scales too small to be resolved in simulations. To study the large-scale impact of these instabilities, we develop a new formalism, based on the large-eddy simulation technique, for the modeling of subgrid-scale turbulent transport in general relativity. We apply it, for the first time, to the simulation of the late-inspiral and merger of two NSs. We find that turbulence can significantly affect the structure and survival time of the merger remnant, as well as its gravitational-wave (GW) and neutrinomore » emissions. The former will be relevant for GW observation of merging NSs. The latter will affect the composition of the outflow driven by the merger and might influence its nucleosynthetic yields. The accretion rate after black hole formation is also affected. Nevertheless, we find that, for the most likely values of the turbulence mixing efficiency, these effects are relatively small and the GW signal will be affected only weakly by the turbulence. Thus, our simulations provide a first validation of all existing post-merger GW models.« less

  15. A New Path-Constrained Rendezvous Planning Approach for Large-Scale Event-Driven Wireless Sensor Networks.

    PubMed

    Vajdi, Ahmadreza; Zhang, Gongxuan; Zhou, Junlong; Wei, Tongquan; Wang, Yongli; Wang, Tianshu

    2018-05-04

    We study the problem of employing a mobile-sink into a large-scale Event-Driven Wireless Sensor Networks (EWSNs) for the purpose of data harvesting from sensor-nodes. Generally, this employment improves the main weakness of WSNs that is about energy-consumption in battery-driven sensor-nodes. The main motivation of our work is to address challenges which are related to a network’s topology by adopting a mobile-sink that moves in a predefined trajectory in the environment. Since, in this fashion, it is not possible to gather data from sensor-nodes individually, we adopt the approach of defining some of the sensor-nodes as Rendezvous Points (RPs) in the network. We argue that RP-planning in this case is a tradeoff between minimizing the number of RPs while decreasing the number of hops for a sensor-node that needs data transformation to the related RP which leads to minimizing average energy consumption in the network. We address the problem by formulating the challenges and expectations as a Mixed Integer Linear Programming (MILP). Henceforth, by proving the NP-hardness of the problem, we propose three effective and distributed heuristics for RP-planning, identifying sojourn locations, and constructing routing trees. Finally, experimental results prove the effectiveness of our approach.

  16. A New Path-Constrained Rendezvous Planning Approach for Large-Scale Event-Driven Wireless Sensor Networks

    PubMed Central

    Zhang, Gongxuan; Wang, Yongli; Wang, Tianshu

    2018-01-01

    We study the problem of employing a mobile-sink into a large-scale Event-Driven Wireless Sensor Networks (EWSNs) for the purpose of data harvesting from sensor-nodes. Generally, this employment improves the main weakness of WSNs that is about energy-consumption in battery-driven sensor-nodes. The main motivation of our work is to address challenges which are related to a network’s topology by adopting a mobile-sink that moves in a predefined trajectory in the environment. Since, in this fashion, it is not possible to gather data from sensor-nodes individually, we adopt the approach of defining some of the sensor-nodes as Rendezvous Points (RPs) in the network. We argue that RP-planning in this case is a tradeoff between minimizing the number of RPs while decreasing the number of hops for a sensor-node that needs data transformation to the related RP which leads to minimizing average energy consumption in the network. We address the problem by formulating the challenges and expectations as a Mixed Integer Linear Programming (MILP). Henceforth, by proving the NP-hardness of the problem, we propose three effective and distributed heuristics for RP-planning, identifying sojourn locations, and constructing routing trees. Finally, experimental results prove the effectiveness of our approach. PMID:29734718

  17. Shock propagation in locally driven granular systems

    NASA Astrophysics Data System (ADS)

    Joy, Jilmy P.; Pathak, Sudhir N.; Das, Dibyendu; Rajesh, R.

    2017-09-01

    We study shock propagation in a system of initially stationary hard spheres that is driven by a continuous injection of particles at the origin. The disturbance created by the injection of energy spreads radially outward through collisions between particles. Using scaling arguments, we determine the exponent characterizing the power-law growth of this disturbance in all dimensions. The scaling functions describing the various physical quantities are determined using large-scale event-driven simulations in two and three dimensions for both elastic and inelastic systems. The results are shown to describe well the data from two different experiments on granular systems that are similarly driven.

  18. Shock propagation in locally driven granular systems.

    PubMed

    Joy, Jilmy P; Pathak, Sudhir N; Das, Dibyendu; Rajesh, R

    2017-09-01

    We study shock propagation in a system of initially stationary hard spheres that is driven by a continuous injection of particles at the origin. The disturbance created by the injection of energy spreads radially outward through collisions between particles. Using scaling arguments, we determine the exponent characterizing the power-law growth of this disturbance in all dimensions. The scaling functions describing the various physical quantities are determined using large-scale event-driven simulations in two and three dimensions for both elastic and inelastic systems. The results are shown to describe well the data from two different experiments on granular systems that are similarly driven.

  19. Design of virtual simulation experiment based on key events

    NASA Astrophysics Data System (ADS)

    Zhong, Zheng; Zhou, Dongbo; Song, Lingxiu

    2018-06-01

    Considering complex content and lacking of guidance in virtual simulation experiments, the key event technology in VR narrative theory was introduced for virtual simulation experiment to enhance fidelity and vividness process. Based on the VR narrative technology, an event transition structure was designed to meet the need of experimental operation process, and an interactive event processing model was used to generate key events in interactive scene. The experiment of" margin value of bees foraging" based on Biologic morphology was taken as an example, many objects, behaviors and other contents were reorganized. The result shows that this method can enhance the user's experience and ensure experimental process complete and effectively.

  20. Disaster Response Modeling Through Discrete-Event Simulation

    NASA Technical Reports Server (NTRS)

    Wang, Jeffrey; Gilmer, Graham

    2012-01-01

    Organizations today are required to plan against a rapidly changing, high-cost environment. This is especially true for first responders to disasters and other incidents, where critical decisions must be made in a timely manner to save lives and resources. Discrete-event simulations enable organizations to make better decisions by visualizing complex processes and the impact of proposed changes before they are implemented. A discrete-event simulation using Simio software has been developed to effectively analyze and quantify the imagery capabilities of domestic aviation resources conducting relief missions. This approach has helped synthesize large amounts of data to better visualize process flows, manage resources, and pinpoint capability gaps and shortfalls in disaster response scenarios. Simulation outputs and results have supported decision makers in the understanding of high risk locations, key resource placement, and the effectiveness of proposed improvements.

  1. LCG MCDB—a knowledgebase of Monte-Carlo simulated events

    NASA Astrophysics Data System (ADS)

    Belov, S.; Dudko, L.; Galkin, E.; Gusev, A.; Pokorski, W.; Sherstnev, A.

    2008-02-01

    In this paper we report on LCG Monte-Carlo Data Base (MCDB) and software which has been developed to operate MCDB. The main purpose of the LCG MCDB project is to provide a storage and documentation system for sophisticated event samples simulated for the LHC Collaborations by experts. In many cases, the modern Monte-Carlo simulation of physical processes requires expert knowledge in Monte-Carlo generators or significant amount of CPU time to produce the events. MCDB is a knowledgebase mainly dedicated to accumulate simulated events of this type. The main motivation behind LCG MCDB is to make the sophisticated MC event samples available for various physical groups. All the data from MCDB is accessible in several convenient ways. LCG MCDB is being developed within the CERN LCG Application Area Simulation project. Program summaryProgram title: LCG Monte-Carlo Data Base Catalogue identifier: ADZX_v1_0 Program summary URL:http://cpc.cs.qub.ac.uk/summaries/ADZX_v1_0.html Program obtainable from: CPC Program Library, Queen's University, Belfast, N. Ireland Licensing provisions: GNU General Public Licence No. of lines in distributed program, including test data, etc.: 30 129 No. of bytes in distributed program, including test data, etc.: 216 943 Distribution format: tar.gz Programming language: Perl Computer: CPU: Intel Pentium 4, RAM: 1 Gb, HDD: 100 Gb Operating system: Scientific Linux CERN 3/4 RAM: 1 073 741 824 bytes (1 Gb) Classification: 9 External routines:perl >= 5.8.5; Perl modules DBD-mysql >= 2.9004, File::Basename, GD::SecurityImage, GD::SecurityImage::AC, Linux::Statistics, XML::LibXML > 1.6, XML::SAX, XML::NamespaceSupport; Apache HTTP Server >= 2.0.59; mod auth external >= 2.2.9; edg-utils-system RPM package; gd >= 2.0.28; rpm package CASTOR-client >= 2.1.2-4; arc-server (optional) Nature of problem: Often, different groups of experimentalists prepare similar samples of particle collision events or turn to the same group of authors of Monte-Carlo (MC

  2. Event-driven contrastive divergence for spiking neuromorphic systems.

    PubMed

    Neftci, Emre; Das, Srinjoy; Pedroni, Bruno; Kreutz-Delgado, Kenneth; Cauwenberghs, Gert

    2013-01-01

    Restricted Boltzmann Machines (RBMs) and Deep Belief Networks have been demonstrated to perform efficiently in a variety of applications, such as dimensionality reduction, feature learning, and classification. Their implementation on neuromorphic hardware platforms emulating large-scale networks of spiking neurons can have significant advantages from the perspectives of scalability, power dissipation and real-time interfacing with the environment. However, the traditional RBM architecture and the commonly used training algorithm known as Contrastive Divergence (CD) are based on discrete updates and exact arithmetics which do not directly map onto a dynamical neural substrate. Here, we present an event-driven variation of CD to train a RBM constructed with Integrate & Fire (I&F) neurons, that is constrained by the limitations of existing and near future neuromorphic hardware platforms. Our strategy is based on neural sampling, which allows us to synthesize a spiking neural network that samples from a target Boltzmann distribution. The recurrent activity of the network replaces the discrete steps of the CD algorithm, while Spike Time Dependent Plasticity (STDP) carries out the weight updates in an online, asynchronous fashion. We demonstrate our approach by training an RBM composed of leaky I&F neurons with STDP synapses to learn a generative model of the MNIST hand-written digit dataset, and by testing it in recognition, generation and cue integration tasks. Our results contribute to a machine learning-driven approach for synthesizing networks of spiking neurons capable of carrying out practical, high-level functionality.

  3. Event-driven contrastive divergence for spiking neuromorphic systems

    PubMed Central

    Neftci, Emre; Das, Srinjoy; Pedroni, Bruno; Kreutz-Delgado, Kenneth; Cauwenberghs, Gert

    2014-01-01

    Restricted Boltzmann Machines (RBMs) and Deep Belief Networks have been demonstrated to perform efficiently in a variety of applications, such as dimensionality reduction, feature learning, and classification. Their implementation on neuromorphic hardware platforms emulating large-scale networks of spiking neurons can have significant advantages from the perspectives of scalability, power dissipation and real-time interfacing with the environment. However, the traditional RBM architecture and the commonly used training algorithm known as Contrastive Divergence (CD) are based on discrete updates and exact arithmetics which do not directly map onto a dynamical neural substrate. Here, we present an event-driven variation of CD to train a RBM constructed with Integrate & Fire (I&F) neurons, that is constrained by the limitations of existing and near future neuromorphic hardware platforms. Our strategy is based on neural sampling, which allows us to synthesize a spiking neural network that samples from a target Boltzmann distribution. The recurrent activity of the network replaces the discrete steps of the CD algorithm, while Spike Time Dependent Plasticity (STDP) carries out the weight updates in an online, asynchronous fashion. We demonstrate our approach by training an RBM composed of leaky I&F neurons with STDP synapses to learn a generative model of the MNIST hand-written digit dataset, and by testing it in recognition, generation and cue integration tasks. Our results contribute to a machine learning-driven approach for synthesizing networks of spiking neurons capable of carrying out practical, high-level functionality. PMID:24574952

  4. Flow-driven rotor simulation of vertical axis tidal turbines: A comparison of helical and straight blades

    NASA Astrophysics Data System (ADS)

    Le, Tuyen Quang; Lee, Kwang-Soo; Park, Jin-Soon; Ko, Jin Hwan

    2014-06-01

    In this study, flow-driven rotor simulations with a given load are conducted to analyze the operational characteristics of a vertical-axis Darrieus turbine, specifically its self-starting capability and fluctuations in its torque as well as the RPM. These characteristics are typically observed in experiments, though they cannot be acquired in simulations with a given tip speed ratio (TSR). First, it is shown that a flow-driven rotor simulation with a two-dimensional (2D) turbine model obtains power coefficients with curves similar to those obtained in a simulation with a given TSR. 3D flowdriven rotor simulations with an optimal geometry then show that a helical-bladed turbine has the following prominent advantages over a straight-bladed turbine of the same size: an improvement of its self-starting capabilities and reduced fluctuations in its torque and RPM curves as well as an increase in its power coefficient from 33% to 42%. Therefore, it is clear that a flow-driven rotor simulation provides more information for the design of a Darrieus turbine than a simulation with a given TSR before experiments.

  5. Widespread, Very Heavy Precipitation Events in Contemporary and Scenario Summer Climates from NARCCAP Simulations

    NASA Astrophysics Data System (ADS)

    Kawazoe, S.; Gutowski, W. J., Jr.

    2015-12-01

    We analyze the ability of regional climate models (RCMs) to simulate very heavy daily precipitation and supporting processes for both contemporary and future-scenario simulations during summer (JJA). RCM output comes from North American Regional Climate Change Assessment Program (NARCCAP) simulations, which are all run at a spatial resolution of 50 km. Analysis focuses on the upper Mississippi basin for summer, between 1982-1998 for the contemporary climate, and 2052-2068 during the scenario climate. We also compare simulated precipitation and supporting processes with those obtained from observed precipitation and reanalysis atmospheric states. Precipitation observations are from the University of Washington (UW) and the Climate Prediction Center (CPC) gridded dataset. Utilizing two observational datasets helps determine if any uncertainties arise from differences in precipitation gridding schemes. Reanalysis fields come from the North American Regional Reanalysis. The NARCCAP models generally reproduce well the precipitation-vs.-intensity spectrum seen in observations, while producing overly strong precipitation at high intensity thresholds. In the future-scenario climate, there is a decrease in frequency for light to moderate precipitation intensities, while an increase in frequency is seen for the higher intensity events. Further analysis focuses on precipitation events exceeding the 99.5 percentile that occur simultaneously at several points in the region, yielding so-called "widespread events". For widespread events, we analyze local and large scale environmental parameters, such as 2-m temperature and specific humidity, 500-hPa geopotential heights, Convective Available Potential Energy (CAPE), vertically integrated moisture flux convergence, among others, to compare atmospheric states and processes leading to such events in the models and observations. The results suggest that an analysis of atmospheric states supporting very heavy precipitation events is a

  6. Interpretation of the 12 May 2012 ground level enhancement event

    NASA Astrophysics Data System (ADS)

    Wu, C. C.; Dryer, Ph D., M.; Liou, K.; Wu, S. T.

    2015-12-01

    The 12 May 2012 solar event is associated with a moderate flare (M5.1) and, surprisingly, a ground level enhancement (GLE) event. It is the first GLE of the solar cycle 24 (or since December 2006). Because GLEs are considered as the highest energy tail in the solar energetic particle (SEP) spectrum, it is generally believed that GLEs must be generated at very strong shocks. Here, we conduct a simulation study of a number of major (> M5.0) flare events that occurred in the current solar cycle up to 2013, using the H3DMHD simulation code. The H3DMHD (Wu et al. 2007, JGR) combines the kinematic solar wind model (HAF) for regions near the solar surface (2.5-18 Rs) and a three-dimensional magnetohydrodynamics model (Han et al. 1988), which takes output from HAF at 18 Rs and propagates outward up to 1.7 AU. The H3DMHD code has been fully tested and is suitable for simulating not only the quiet solar wind, but also disturbances propagating in the solar wind. Our preliminary study result suggests that the 12 May 2012 was magnetically well connected, whereas others were not. We will present the detailed result, including the shock structure and intensity driven by the 12 May 2012 CME event, and discuss the result implication.

  7. Event-Driven Technology to Generate Relevant Collections of Near-Realtime Data

    NASA Astrophysics Data System (ADS)

    Graves, S. J.; Keiser, K.; Nair, U. S.; Beck, J. M.; Ebersole, S.

    2017-12-01

    Getting the right data when it is needed continues to be a challenge for researchers and decision makers. Event-Driven Data Delivery (ED3), funded by the NASA Applied Science program, is a technology that allows researchers and decision makers to pre-plan what data, information and processes they need to have collected or executed in response to future events. The Information Technology and Systems Center at the University of Alabama in Huntsville (UAH) has developed the ED3 framework in collaboration with atmospheric scientists at UAH, scientists at the Geological Survey of Alabama, and other federal, state and local stakeholders to meet the data preparedness needs for research, decisions and situational awareness. The ED3 framework supports an API that supports the addition of loosely-coupled, distributed event handlers and data processes. This approach allows the easy addition of new events and data processes so the system can scale to support virtually any type of event or data process. Using ED3's underlying services, applications have been developed that monitor for alerts of registered event types and automatically triggers subscriptions that match new events, providing users with a living "album" of results that can continued to be curated as more information for an event becomes available. This capability can allow users to improve capacity for the collection, creation and use of data and real-time processes (data access, model execution, product generation, sensor tasking, social media filtering, etc), in response to disaster (and other) events by preparing in advance for data and information needs for future events. This presentation will provide an update on the ED3 developments and deployments, and further explain the applicability for utilizing near-realtime data in hazards research, response and situational awareness.

  8. Simulation on the Performance of a Driven Fan Made by Polyester/Epoxy interpenetrate polymer network (IPN)

    NASA Astrophysics Data System (ADS)

    Fahrul Hassan, Mohd; Jamri, Azmil; Nawawi, Azli; Zaini Yunos, Muhamad; Fauzi Ahmad, Md; Adzila, Sharifah; Nasrull Abdol Rahman, Mohd

    2017-08-01

    The main purpose of this study is to investigate the performance of a driven fan design made by Polyester/Epoxy interpenetrate polymer network (IPN) material that specifically used for turbocharger compressor. Polyester/Epoxy IPN is polymer plastics that was used as replacements for traditional polymers and has been widely used in a variety of applications because of their limitless conformations. Simulation based on several parameters which are air pressure, air velocity and air temperature have been carried out for a driven fan design performance of two different materials, aluminum alloy (existing driven fan design) and Polyester/Epoxy IPN using SolidWorks Flow Simulation software. Results from both simulations were analyzed and compared where both materials show similar performance in terms of air pressure and air velocity due to similar geometric and dimension, but Polyester/Epoxy IPN produces lower air temperature than aluminum alloy. This study shows a preliminary result of the potential Polyester/Epoxy IPN to be used as a driven fan design material. In the future, further studies will be conducted on detail simulation and experimental analysis.

  9. A general CFD framework for fault-resilient simulations based on multi-resolution information fusion

    NASA Astrophysics Data System (ADS)

    Lee, Seungjoon; Kevrekidis, Ioannis G.; Karniadakis, George Em

    2017-10-01

    We develop a general CFD framework for multi-resolution simulations to target multiscale problems but also resilience in exascale simulations, where faulty processors may lead to gappy, in space-time, simulated fields. We combine approximation theory and domain decomposition together with statistical learning techniques, e.g. coKriging, to estimate boundary conditions and minimize communications by performing independent parallel runs. To demonstrate this new simulation approach, we consider two benchmark problems. First, we solve the heat equation (a) on a small number of spatial "patches" distributed across the domain, simulated by finite differences at fine resolution and (b) on the entire domain simulated at very low resolution, thus fusing multi-resolution models to obtain the final answer. Second, we simulate the flow in a lid-driven cavity in an analogous fashion, by fusing finite difference solutions obtained with fine and low resolution assuming gappy data sets. We investigate the influence of various parameters for this framework, including the correlation kernel, the size of a buffer employed in estimating boundary conditions, the coarseness of the resolution of auxiliary data, and the communication frequency across different patches in fusing the information at different resolution levels. In addition to its robustness and resilience, the new framework can be employed to generalize previous multiscale approaches involving heterogeneous discretizations or even fundamentally different flow descriptions, e.g. in continuum-atomistic simulations.

  10. A Distributed Laboratory for Event-Driven Coastal Prediction and Hazard Planning

    NASA Astrophysics Data System (ADS)

    Bogden, P.; Allen, G.; MacLaren, J.; Creager, G. J.; Flournoy, L.; Sheng, Y. P.; Graber, H.; Graves, S.; Conover, H.; Luettich, R.; Perrie, W.; Ramakrishnan, L.; Reed, D. A.; Wang, H. V.

    2006-12-01

    The 2005 Atlantic hurricane season was the most active in recorded history. Collectively, 2005 hurricanes caused more than 2,280 deaths and record damages of over 100 billion dollars. Of the storms that made landfall, Dennis, Emily, Katrina, Rita, and Wilma caused most of the destruction. Accurate predictions of storm-driven surge, wave height, and inundation can save lives and help keep recovery costs down, provided the information gets to emergency response managers in time. The information must be available well in advance of landfall so that responders can weigh the costs of unnecessary evacuation against the costs of inadequate preparation. The SURA Coastal Ocean Observing and Prediction (SCOOP) Program is a multi-institution collaboration implementing a modular, distributed service-oriented architecture for real time prediction and visualization of the impacts of extreme atmospheric events. The modular infrastructure enables real-time prediction of multi- scale, multi-model, dynamic, data-driven applications. SURA institutions are working together to create a virtual and distributed laboratory integrating coastal models, simulation data, and observations with computational resources and high speed networks. The loosely coupled architecture allows teams of computer and coastal scientists at multiple institutions to innovate complex system components that are interconnected with relatively stable interfaces. The operational system standardizes at the interface level to enable substantial innovation by complementary communities of coastal and computer scientists. This architectural philosophy solves a long-standing problem associated with the transition from research to operations. The SCOOP Program thereby implements a prototype laboratory consistent with the vision of a national, multi-agency initiative called the Integrated Ocean Observing System (IOOS). Several service- oriented components of the SCOOP enterprise architecture have already been designed and

  11. Spiking neural network simulation: memory-optimal synaptic event scheduling.

    PubMed

    Stewart, Robert D; Gurney, Kevin N

    2011-06-01

    Spiking neural network simulations incorporating variable transmission delays require synaptic events to be scheduled prior to delivery. Conventional methods have memory requirements that scale with the total number of synapses in a network. We introduce novel scheduling algorithms for both discrete and continuous event delivery, where the memory requirement scales instead with the number of neurons. Superior algorithmic performance is demonstrated using large-scale, benchmarking network simulations.

  12. Uncertainty estimation of simulated water levels for the Mitch flood event in Tegucigalpa

    NASA Astrophysics Data System (ADS)

    Fuentes Andino, Diana Carolina; Halldin, Sven; Keith, Beven; Chong-Yu, Xu

    2013-04-01

    Hurricane Mitch in 1998 left a devastating flood in Tegucigalpa, the capital city of Honduras. Due to the extremely large magnitude of the Mitch flood, hydrometric measurements were not taken during the event. However, post-event indirect measurements of the discharge were obtained by the U.S. Geological Survey (USGS) and post-event surveyed high water marks were obtained by the Japan International Cooperation agency (JICA). This work proposes a methodology to simulate the water level during the Mitch event when the available data is associated with large uncertainty. The results of the two-dimensional hydrodynamic model LISFLOOD-FP will be evaluated using the Generalized Uncertainty Estimation (GLUE) framework. The main challenge in the proposed methodology is to formulate an approach to evaluate the model results when there are large uncertainties coming from both the model parameters and the evaluation data.

  13. FusionAnalyser: a new graphical, event-driven tool for fusion rearrangements discovery

    PubMed Central

    Piazza, Rocco; Pirola, Alessandra; Spinelli, Roberta; Valletta, Simona; Redaelli, Sara; Magistroni, Vera; Gambacorti-Passerini, Carlo

    2012-01-01

    Gene fusions are common driver events in leukaemias and solid tumours; here we present FusionAnalyser, a tool dedicated to the identification of driver fusion rearrangements in human cancer through the analysis of paired-end high-throughput transcriptome sequencing data. We initially tested FusionAnalyser by using a set of in silico randomly generated sequencing data from 20 known human translocations occurring in cancer and subsequently using transcriptome data from three chronic and three acute myeloid leukaemia samples. in all the cases our tool was invariably able to detect the presence of the correct driver fusion event(s) with high specificity. In one of the acute myeloid leukaemia samples, FusionAnalyser identified a novel, cryptic, in-frame ETS2–ERG fusion. A fully event-driven graphical interface and a flexible filtering system allow complex analyses to be run in the absence of any a priori programming or scripting knowledge. Therefore, we propose FusionAnalyser as an efficient and robust graphical tool for the identification of functional rearrangements in the context of high-throughput transcriptome sequencing data. PMID:22570408

  14. FusionAnalyser: a new graphical, event-driven tool for fusion rearrangements discovery.

    PubMed

    Piazza, Rocco; Pirola, Alessandra; Spinelli, Roberta; Valletta, Simona; Redaelli, Sara; Magistroni, Vera; Gambacorti-Passerini, Carlo

    2012-09-01

    Gene fusions are common driver events in leukaemias and solid tumours; here we present FusionAnalyser, a tool dedicated to the identification of driver fusion rearrangements in human cancer through the analysis of paired-end high-throughput transcriptome sequencing data. We initially tested FusionAnalyser by using a set of in silico randomly generated sequencing data from 20 known human translocations occurring in cancer and subsequently using transcriptome data from three chronic and three acute myeloid leukaemia samples. in all the cases our tool was invariably able to detect the presence of the correct driver fusion event(s) with high specificity. In one of the acute myeloid leukaemia samples, FusionAnalyser identified a novel, cryptic, in-frame ETS2-ERG fusion. A fully event-driven graphical interface and a flexible filtering system allow complex analyses to be run in the absence of any a priori programming or scripting knowledge. Therefore, we propose FusionAnalyser as an efficient and robust graphical tool for the identification of functional rearrangements in the context of high-throughput transcriptome sequencing data.

  15. The cost of conservative synchronization in parallel discrete event simulations

    NASA Technical Reports Server (NTRS)

    Nicol, David M.

    1990-01-01

    The performance of a synchronous conservative parallel discrete-event simulation protocol is analyzed. The class of simulation models considered is oriented around a physical domain and possesses a limited ability to predict future behavior. A stochastic model is used to show that as the volume of simulation activity in the model increases relative to a fixed architecture, the complexity of the average per-event overhead due to synchronization, event list manipulation, lookahead calculations, and processor idle time approach the complexity of the average per-event overhead of a serial simulation. The method is therefore within a constant factor of optimal. The analysis demonstrates that on large problems--those for which parallel processing is ideally suited--there is often enough parallel workload so that processors are not usually idle. The viability of the method is also demonstrated empirically, showing how good performance is achieved on large problems using a thirty-two node Intel iPSC/2 distributed memory multiprocessor.

  16. Intelligent fuzzy controller for event-driven real time systems

    NASA Technical Reports Server (NTRS)

    Grantner, Janos; Patyra, Marek; Stachowicz, Marian S.

    1992-01-01

    Most of the known linguistic models are essentially static, that is, time is not a parameter in describing the behavior of the object's model. In this paper we show a model for synchronous finite state machines based on fuzzy logic. Such finite state machines can be used to build both event-driven, time-varying, rule-based systems and the control unit section of a fuzzy logic computer. The architecture of a pipelined intelligent fuzzy controller is presented, and the linguistic model is represented by an overall fuzzy relation stored in a single rule memory. A VLSI integrated circuit implementation of the fuzzy controller is suggested. At a clock rate of 30 MHz, the controller can perform 3 MFLIPS on multi-dimensional fuzzy data.

  17. Performance of technology-driven simulators for medical students--a systematic review.

    PubMed

    Michael, Michael; Abboudi, Hamid; Ker, Jean; Shamim Khan, Mohammed; Dasgupta, Prokar; Ahmed, Kamran

    2014-12-01

    Simulation-based education has evolved as a key training tool in high-risk industries such as aviation and the military. In parallel with these industries, the benefits of incorporating specialty-oriented simulation training within medical schools are vast. Adoption of simulators into medical school education programs has shown great promise and has the potential to revolutionize modern undergraduate education. An English literature search was carried out using MEDLINE, EMBASE, and psychINFO databases to identify all randomized controlled studies pertaining to "technology-driven" simulators used in undergraduate medical education. A validity framework incorporating the "framework for technology enhanced learning" report by the Department of Health, United Kingdom, was used to evaluate the capabilities of each technology-driven simulator. Information was collected regarding the simulator type, characteristics, and brand name. Where possible, we extracted information from the studies on the simulators' performance with respect to validity status, reliability, feasibility, education impact, acceptability, and cost effectiveness. We identified 19 studies, analyzing simulators for medical students across a variety of procedure-based specialities including; cardiovascular (n = 2), endoscopy (n = 3), laparoscopic surgery (n = 8), vascular access (n = 2), ophthalmology (n = 1), obstetrics and gynecology (n = 1), anesthesia (n = 1), and pediatrics (n = 1). Incorporation of simulators has so far been on an institutional level; no national or international trends have yet emerged. Simulators are capable of providing a highly educational and realistic experience for the medical students within a variety of speciality-oriented teaching sessions. Further research is needed to establish how best to incorporate simulators into a more primary stage of medical education; preclinical and clinical undergraduate medicine. Copyright © 2014 Elsevier Inc. All rights

  18. WE-G-BRA-02: SafetyNet: Automating Radiotherapy QA with An Event Driven Framework

    DOE Office of Scientific and Technical Information (OSTI.GOV)

    Hadley, S; Kessler, M; Litzenberg, D

    2015-06-15

    Purpose: Quality assurance is an essential task in radiotherapy that often requires many manual tasks. We investigate the use of an event driven framework in conjunction with software agents to automate QA and eliminate wait times. Methods: An in house developed subscription-publication service, EventNet, was added to the Aria OIS to be a message broker for critical events occurring in the OIS and software agents. Software agents operate without user intervention and perform critical QA steps. The results of the QA are documented and the resulting event is generated and passed back to EventNet. Users can subscribe to those eventsmore » and receive messages based on custom filters designed to send passing or failing results to physicists or dosimetrists. Agents were developed to expedite the following QA tasks: Plan Revision, Plan 2nd Check, SRS Winston-Lutz isocenter, Treatment History Audit, Treatment Machine Configuration. Results: Plan approval in the Aria OIS was used as the event trigger for plan revision QA and Plan 2nd check agents. The agents pulled the plan data, executed the prescribed QA, stored the results and updated EventNet for publication. The Winston Lutz agent reduced QA time from 20 minutes to 4 minutes and provided a more accurate quantitative estimate of radiation isocenter. The Treatment Machine Configuration agent automatically reports any changes to the Treatment machine or HDR unit configuration. The agents are reliable, act immediately, and execute each task identically every time. Conclusion: An event driven framework has inverted the data chase in our radiotherapy QA process. Rather than have dosimetrists and physicists push data to QA software and pull results back into the OIS, the software agents perform these steps immediately upon receiving the sentinel events from EventNet. Mr Keranen is an employee of Varian Medical Systems. Dr. Moran’s institution receives research support for her effort for a linear accelerator QA project

  19. Mechanics of Interrill Erosion with Wind-Driven Rain (WDR)

    USDA-ARS?s Scientific Manuscript database

    This article provides an evaluation analysis for the performance of the interrill component of the Water Erosion Prediction Project (WEPP) model for Wind-Driven Rain (WDR) events. The interrill delivery rates (Di) were collected in the wind tunnel rainfall simulator facility of the International Cen...

  20. Large eddy simulations of time-dependent and buoyancy-driven channel flows

    NASA Technical Reports Server (NTRS)

    Cabot, William H.

    1993-01-01

    The primary goal of this work has been to assess the performance of the dynamic SGS model in the large eddy simulation (LES) of channel flows in a variety of situations, viz., in temporal development of channel flow turned by a transverse pressure gradient and especially in buoyancy-driven turbulent flows such as Rayleigh-Benard and internally heated channel convection. For buoyancy-driven flows, there are additional buoyant terms that are possible in the base models, and one objective has been to determine if the dynamic SGS model results are sensitive to such terms. The ultimate goal is to determine the minimal base model needed in the dynamic SGS model to provide accurate results in flows with more complicated physical features. In addition, a program of direct numerical simulation (DNS) of fully compressible channel convection has been undertaken to determine stratification and compressibility effects. These simulations are intended to provide a comparative base for performing the LES of compressible (or highly stratified, pseudo-compressible) convection at high Reynolds number in the future.

  1. Three Dimensional Simulation of the Baneberry Nuclear Event

    NASA Astrophysics Data System (ADS)

    Lomov, Ilya N.; Antoun, Tarabay H.; Wagoner, Jeff; Rambo, John T.

    2004-07-01

    Baneberry, a 10-kiloton nuclear event, was detonated at a depth of 278 m at the Nevada Test Site on December 18, 1970. Shortly after detonation, radioactive gases emanating from the cavity were released into the atmosphere through a shock-induced fissure near surface ground zero. Extensive geophysical investigations, coupled with a series of 1D and 2D computational studies were used to reconstruct the sequence of events that led to the catastrophic failure. However, the geological profile of the Baneberry site is complex and inherently three-dimensional, which meant that some geological features had to be simplified or ignored in the 2D simulations. This left open the possibility that features unaccounted for in the 2D simulations could have had an important influence on the eventual containment failure of the Baneberry event. This paper presents results from a high-fidelity 3D Baneberry simulation based on the most accurate geologic and geophysical data available. The results are compared with available data, and contrasted against the results of the previous 2D computational studies.

  2. Optimization of Operations Resources via Discrete Event Simulation Modeling

    NASA Technical Reports Server (NTRS)

    Joshi, B.; Morris, D.; White, N.; Unal, R.

    1996-01-01

    The resource levels required for operation and support of reusable launch vehicles are typically defined through discrete event simulation modeling. Minimizing these resources constitutes an optimization problem involving discrete variables and simulation. Conventional approaches to solve such optimization problems involving integer valued decision variables are the pattern search and statistical methods. However, in a simulation environment that is characterized by search spaces of unknown topology and stochastic measures, these optimization approaches often prove inadequate. In this paper, we have explored the applicability of genetic algorithms to the simulation domain. Genetic algorithms provide a robust search strategy that does not require continuity and differentiability of the problem domain. The genetic algorithm successfully minimized the operation and support activities for a space vehicle, through a discrete event simulation model. The practical issues associated with simulation optimization, such as stochastic variables and constraints, were also taken into consideration.

  3. The oceanic boundary layer driven by wave breaking with stochastic variability. Part 1. Direct numerical simulations

    NASA Astrophysics Data System (ADS)

    Sullivan, Peter P.; McWilliams, James C.; Melville, W. Kendall

    2004-05-01

    We devise a stochastic model for the effects of breaking waves and fit its distribution functions to laboratory and field data. This is used to represent the space time structure of momentum and energy forcing of the oceanic boundary layer in turbulence-resolving simulations. The aptness of this breaker model is evaluated in a direct numerical simulation (DNS) of an otherwise quiescent fluid driven by an isolated breaking wave, and the results are in good agreement with laboratory measurements. The breaker model faithfully reproduces the bulk features of a breaking event: the mean kinetic energy decays at a rate approaching t(-1) , and a long-lived vortex (eddy) is generated close to the water surface. The long lifetime of this vortex (more than 50 wave periods) makes it effective in energizing the surface region of oceanic boundary layers. Next, a comparison of several different DNS of idealized oceanic boundary layers driven by different surface forcing (i.e. constant current (as in Couette flow), constant stress, or a mixture of constant stress plus stochastic breakers) elucidates the importance of intermittent stress transmission to the underlying currents. A small amount of active breaking, about 1.6% of the total water surface area at any instant in time, significantly alters the instantaneous flow patterns as well as the ensemble statistics. Near the water surface a vigorous downwelling upwelling pattern develops at the head and tail of each three-dimensional breaker. This enhances the vertical velocity variance and generates both negative- and positive-signed vertical momentum flux. Analysis of the mean velocity and scalar profiles shows that breaking effectively increases the surface roughness z_o by more than a factor of 30; for our simulations z_o/lambda {≈} 0.04 to 0.06, where lambda is the wavelength of the breaking wave. Compared to a flow driven by a constant current, the extra mixing from breakers increases the mean eddy viscosity by more than a

  4. Algorithms and architecture for multiprocessor based circuit simulation

    DOE Office of Scientific and Technical Information (OSTI.GOV)

    Deutsch, J.T.

    Accurate electrical simulation is critical to the design of high performance integrated circuits. Logic simulators can verify function and give first-order timing information. Switch level simulators are more effective at dealing with charge sharing than standard logic simulators, but cannot provide accurate timing information or discover DC problems. Delay estimation techniques and cell level simulation can be used in constrained design methods, but must be tuned for each application, and circuit simulation must still be used to generate the cell models. None of these methods has the guaranteed accuracy that many circuit designers desire, and none can provide detailed waveformmore » information. Detailed electrical-level simulation can predict circuit performance if devices and parasitics are modeled accurately. However, the computational requirements of conventional circuit simulators make it impractical to simulate current large circuits. In this dissertation, the implementation of Iterated Timing Analysis (ITA), a relaxation-based technique for accurate circuit simulation, on a special-purpose multiprocessor is presented. The ITA method is an SOR-Newton, relaxation-based method which uses event-driven analysis and selective trace to exploit the temporal sparsity of the electrical network. Because event-driven selective trace techniques are employed, this algorithm lends itself to implementation on a data-driven computer.« less

  5. Power-Law Statistics of Driven Reconnection in the Magnetically Closed Corona

    NASA Technical Reports Server (NTRS)

    Klimchuk, J. A.; DeVore, C. R.; Knizhnik, K. J.; Uritskiy, V. M.

    2018-01-01

    Numerous observations have revealed that power-law distributions are ubiquitous in energetic solar processes. Hard X-rays, soft X-rays, extreme ultraviolet radiation, and radio waves all display power-law frequency distributions. Since magnetic reconnection is the driving mechanism for many energetic solar phenomena, it is likely that reconnection events themselves display such power-law distributions. In this work, we perform numerical simulations of the solar corona driven by simple convective motions at the photospheric level. Using temperature changes, current distributions, and Poynting fluxes as proxies for heating, we demonstrate that energetic events occurring in our simulation display power-law frequency distributions, with slopes in good agreement with observations. We suggest that the braiding-associated reconnection in the corona can be understood in terms of a self-organized criticality model driven by convective rotational motions similar to those observed at the photosphere.

  6. Event-driven visual attention for the humanoid robot iCub

    PubMed Central

    Rea, Francesco; Metta, Giorgio; Bartolozzi, Chiara

    2013-01-01

    Fast reaction to sudden and potentially interesting stimuli is a crucial feature for safe and reliable interaction with the environment. Here we present a biologically inspired attention system developed for the humanoid robot iCub. It is based on input from unconventional event-driven vision sensors and an efficient computational method. The resulting system shows low-latency and fast determination of the location of the focus of attention. The performance is benchmarked against an instance of the state of the art in robotics artificial attention system used in robotics. Results show that the proposed system is two orders of magnitude faster that the benchmark in selecting a new stimulus to attend. PMID:24379753

  7. Full-Body Musculoskeletal Model for Muscle-Driven Simulation of Human Gait.

    PubMed

    Rajagopal, Apoorva; Dembia, Christopher L; DeMers, Matthew S; Delp, Denny D; Hicks, Jennifer L; Delp, Scott L

    2016-10-01

    Musculoskeletal models provide a non-invasive means to study human movement and predict the effects of interventions on gait. Our goal was to create an open-source 3-D musculoskeletal model with high-fidelity representations of the lower limb musculature of healthy young individuals that can be used to generate accurate simulations of gait. Our model includes bony geometry for the full body, 37 degrees of freedom to define joint kinematics, Hill-type models of 80 muscle-tendon units actuating the lower limbs, and 17 ideal torque actuators driving the upper body. The model's musculotendon parameters are derived from previous anatomical measurements of 21 cadaver specimens and magnetic resonance images of 24 young healthy subjects. We tested the model by evaluating its computational time and accuracy of simulations of healthy walking and running. Generating muscle-driven simulations of normal walking and running took approximately 10 minutes on a typical desktop computer. The differences between our muscle-generated and inverse dynamics joint moments were within 3% (RMSE) of the peak inverse dynamics joint moments in both walking and running, and our simulated muscle activity showed qualitative agreement with salient features from experimental electromyography data. These results suggest that our model is suitable for generating muscle-driven simulations of healthy gait. We encourage other researchers to further validate and apply the model to study other motions of the lower extremity. The model is implemented in the open-source software platform OpenSim. The model and data used to create and test the simulations are freely available at https://simtk.org/home/full_body/, allowing others to reproduce these results and create their own simulations.

  8. Initial conditions and modeling for simulations of shock driven turbulent material mixing

    DOE PAGES

    Grinstein, Fernando F.

    2016-11-17

    Here, we focus on the simulation of shock-driven material mixing driven by flow instabilities and initial conditions (IC). Beyond complex multi-scale resolution issues of shocks and variable density turbulence, me must address the equally difficult problem of predicting flow transition promoted by energy deposited at the material interfacial layer during the shock interface interactions. Transition involves unsteady large-scale coherent-structure dynamics capturable by a large eddy simulation (LES) strategy, but not by an unsteady Reynolds-Averaged Navier–Stokes (URANS) approach based on developed equilibrium turbulence assumptions and single-point-closure modeling. On the engineering end of computations, such URANS with reduced 1D/2D dimensionality and coarsermore » grids, tend to be preferred for faster turnaround in full-scale configurations.« less

  9. Maximum Principle for General Controlled Systems Driven by Fractional Brownian Motions

    DOE Office of Scientific and Technical Information (OSTI.GOV)

    Han Yuecai; Hu Yaozhong; Song Jian, E-mail: jsong2@math.rutgers.edu

    2013-04-15

    We obtain a maximum principle for stochastic control problem of general controlled stochastic differential systems driven by fractional Brownian motions (of Hurst parameter H>1/2). This maximum principle specifies a system of equations that the optimal control must satisfy (necessary condition for the optimal control). This system of equations consists of a backward stochastic differential equation driven by both fractional Brownian motions and the corresponding underlying standard Brownian motions. In addition to this backward equation, the maximum principle also involves the Malliavin derivatives. Our approach is to use conditioning and Malliavin calculus. To arrive at our maximum principle we need tomore » develop some new results of stochastic analysis of the controlled systems driven by fractional Brownian motions via fractional calculus. Our approach of conditioning and Malliavin calculus is also applied to classical system driven by standard Brownian motions while the controller has only partial information. As a straightforward consequence, the classical maximum principle is also deduced in this more natural and simpler way.« less

  10. General Relativistic Simulations of Magnetized Plasmas Around Merging Supermassive Black Holes

    NASA Technical Reports Server (NTRS)

    Giacomazzo, Bruno; Baker, John G.; Miller, M. Coleman; Reynolds, Christopher S.; van Meter, James R.

    2012-01-01

    Coalescing supermassive black hole binaries are produced by the mergers of galaxies and are the most powerful sources of gravitational waves accessible to space-based gravitational observatories. Some such mergers may occur in the presence of matter and magnetic fields and hence generate an electromagnetic counterpart. In this paper we present the first general relativistic simulations of magnetized plasma around merging supermassive black holes using the general relativistic magnetohydrodynamic code Whisky. By considering different magnetic field strengths, going from non-magnetically dominated to magnetically dominated regimes, we explore how magnetic fields affect the dynamics of the plasma and the possible emission of electromagnetic signals. In particular we observe, total amplification of the magnetic field of approx 2 orders of magnitude which is driven by the accretion onto the binary and that leads to stronger electromagnetic signals than in the force-free regime where such amplifications are not possible.

  11. Improving prospective memory performance with future event simulation in traumatic brain injury patients.

    PubMed

    Mioni, Giovanna; Bertucci, Erica; Rosato, Antonella; Terrett, Gill; Rendell, Peter G; Zamuner, Massimo; Stablum, Franca

    2017-06-01

    Previous studies have shown that traumatic brain injury (TBI) patients have difficulties with prospective memory (PM). Considering that PM is closely linked to independent living it is of primary interest to develop strategies that can improve PM performance in TBI patients. This study employed Virtual Week task as a measure of PM, and we included future event simulation to boost PM performance. Study 1 evaluated the efficacy of the strategy and investigated possible practice effects. Twenty-four healthy participants performed Virtual Week in a no strategy condition, and 24 healthy participants performed it in a mixed condition (no strategy - future event simulation). In Study 2, 18 TBI patients completed the mixed condition of Virtual Week and were compared with the 24 healthy controls who undertook the mixed condition of Virtual Week in Study 1. All participants also completed a neuropsychological evaluation to characterize the groups on level of cognitive functioning. Study 1 showed that participants in the future event simulation condition outperformed participants in the no strategy condition, and these results were not attributable to practice effects. Results of Study 2 showed that TBI patients performed PM tasks less accurately than controls, but that future event simulation can substantially reduce TBI-related deficits in PM performance. The future event simulation strategy also improved the controls' PM performance. These studies showed the value of future event simulation strategy in improving PM performance in healthy participants as well as in TBI patients. TBI patients performed PM tasks less accurately than controls, confirming prospective memory impairment in these patients. Participants in the future event simulation condition out-performed participants in the no strategy condition. Future event simulation can substantially reduce TBI-related deficits in PM performance. Future event simulation strategy also improved the controls' PM performance.

  12. Running Parallel Discrete Event Simulators on Sierra

    DOE Office of Scientific and Technical Information (OSTI.GOV)

    Barnes, P. D.; Jefferson, D. R.

    2015-12-03

    In this proposal we consider porting the ROSS/Charm++ simulator and the discrete event models that run under its control so that they run on the Sierra architecture and make efficient use of the Volta GPUs.

  13. Kinetic modeling of x-ray laser-driven solid Al plasmas via particle-in-cell simulation

    NASA Astrophysics Data System (ADS)

    Royle, R.; Sentoku, Y.; Mancini, R. C.; Paraschiv, I.; Johzaki, T.

    2017-06-01

    Solid-density plasmas driven by intense x-ray free-electron laser (XFEL) radiation are seeded by sources of nonthermal photoelectrons and Auger electrons that ionize and heat the target via collisions. Simulation codes that are commonly used to model such plasmas, such as collisional-radiative (CR) codes, typically assume a Maxwellian distribution and thus instantaneous thermalization of the source electrons. In this study, we present a detailed description and initial applications of a collisional particle-in-cell code, picls, that has been extended with a self-consistent radiation transport model and Monte Carlo models for photoionization and K L L Auger ionization, enabling the fully kinetic simulation of XFEL-driven plasmas. The code is used to simulate two experiments previously performed at the Linac Coherent Light Source investigating XFEL-driven solid-density Al plasmas. It is shown that picls-simulated pulse transmissions using the Ecker-Kröll continuum-lowering model agree much better with measurements than do simulations using the Stewart-Pyatt model. Good quantitative agreement is also found between the time-dependent picls results and those of analogous simulations by the CR code scfly, which was used in the analysis of the experiments to accurately reproduce the observed K α emissions and pulse transmissions. Finally, it is shown that the effects of the nonthermal electrons are negligible for the conditions of the particular experiments under investigation.

  14. Discrete event simulation: the preferred technique for health economic evaluations?

    PubMed

    Caro, Jaime J; Möller, Jörgen; Getsios, Denis

    2010-12-01

    To argue that discrete event simulation should be preferred to cohort Markov models for economic evaluations in health care. The basis for the modeling techniques is reviewed. For many health-care decisions, existing data are insufficient to fully inform them, necessitating the use of modeling to estimate the consequences that are relevant to decision-makers. These models must reflect what is known about the problem at a level of detail sufficient to inform the questions. Oversimplification will result in estimates that are not only inaccurate, but potentially misleading. Markov cohort models, though currently popular, have so many limitations and inherent assumptions that they are inadequate to inform most health-care decisions. An event-based individual simulation offers an alternative much better suited to the problem. A properly designed discrete event simulation provides more accurate, relevant estimates without being computationally prohibitive. It does require more data and may be a challenge to convey transparently, but these are necessary trade-offs to provide meaningful and valid results. In our opinion, discrete event simulation should be the preferred technique for health economic evaluations today. © 2010, International Society for Pharmacoeconomics and Outcomes Research (ISPOR).

  15. ANALYSIS OF INPATIENT HOSPITAL STAFF MENTAL WORKLOAD BY MEANS OF DISCRETE-EVENT SIMULATION

    DTIC Science & Technology

    2016-03-24

    ANALYSIS OF INPATIENT HOSPITAL STAFF MENTAL WORKLOAD BY MEANS OF DISCRETE -EVENT SIMULATION...in the United States. AFIT-ENV-MS-16-M-166 ANALYSIS OF INPATIENT HOSPITAL STAFF MENTAL WORKLOAD BY MEANS OF DISCRETE -EVENT SIMULATION...UNLIMITED. AFIT-ENV-MS-16-M-166 ANALYSIS OF INPATIENT HOSPITAL STAFF MENTAL WORKLOAD BY MEANS OF DISCRETE -EVENT SIMULATION Erich W

  16. Manual for the Jet Event and Background Simulation Library(JEBSimLib)

    DOE Office of Scientific and Technical Information (OSTI.GOV)

    Heinz, Matthias; Soltz, Ron; Angerami, Aaron

    Jets are the collimated streams of particles resulting from hard scattering in the initial state of high-energy collisions. In heavy-ion collisions, jets interact with the quark-gluon plasma (QGP) before freezeout, providing a probe into the internal structure and properties of the QGP. In order to study jets, background must be subtracted from the measured event, potentially introducing a bias. We aim to understand and quantify this subtraction bias. PYTHIA, a library to simulate pure jet events, is used to simulate a model for a signature with one pure jet (a photon) and one quenched jet, where all quenched particle momentamore » are reduced by a user-de ned constant fraction. Background for the event is simulated using multiplicity values generated by the TRENTO initial state model of heavy-ion collisions fed into a thermal model consisting of a 3-dimensional Boltzmann distribution for particle types and momenta. Data from the simulated events is used to train a statistical model, which computes a posterior distribution of the quench factor for a data set. The model was tested rst on pure jet events and then on full events including the background. This model will allow for a quantitative determination of biases induced by various methods of background subtraction.« less

  17. Simulation and study of small numbers of random events

    NASA Technical Reports Server (NTRS)

    Shelton, R. D.

    1986-01-01

    Random events were simulated by computer and subjected to various statistical methods to extract important parameters. Various forms of curve fitting were explored, such as least squares, least distance from a line, maximum likelihood. Problems considered were dead time, exponential decay, and spectrum extraction from cosmic ray data using binned data and data from individual events. Computer programs, mostly of an iterative nature, were developed to do these simulations and extractions and are partially listed as appendices. The mathematical basis for the compuer programs is given.

  18. Improving outpatient phlebotomy service efficiency and patient experience using discrete-event simulation.

    PubMed

    Yip, Kenneth; Pang, Suk-King; Chan, Kui-Tim; Chan, Chi-Kuen; Lee, Tsz-Leung

    2016-08-08

    Purpose - The purpose of this paper is to present a simulation modeling application to reconfigure the outpatient phlebotomy service of an acute regional and teaching hospital in Hong Kong, with an aim to improve service efficiency, shorten patient queuing time and enhance workforce utilization. Design/methodology/approach - The system was modeled as an inhomogeneous Poisson process and a discrete-event simulation model was developed to simulate the current setting, and to evaluate how various performance metrics would change if switched from a decentralized to a centralized model. Variations were then made to the model to test different workforce arrangements for the centralized service, so that managers could decide on the service's final configuration via an evidence-based and data-driven approach. Findings - This paper provides empirical insights about the relationship between staffing arrangement and system performance via a detailed scenario analysis. One particular staffing scenario was chosen by manages as it was considered to strike the best balance between performance and workforce scheduled. The resulting centralized phlebotomy service was successfully commissioned. Practical implications - This paper demonstrates how analytics could be used for operational planning at the hospital level. The authors show that a transparent and evidence-based scenario analysis, made available through analytics and simulation, greatly facilitates management and clinical stakeholders to arrive at the ideal service configuration. Originality/value - The authors provide a robust method in evaluating the relationship between workforce investment, queuing reduction and workforce utilization, which is crucial for managers when deciding the delivery model for any outpatient-related service.

  19. Variability of simulants used in recreating stab events.

    PubMed

    Carr, D J; Wainwright, A

    2011-07-15

    Forensic investigators commonly use simulants/backing materials to mount fabrics and/or garments on when recreating damage due to stab events. Such work may be conducted in support of an investigation to connect a particular knife to a stabbing event by comparing the severance morphology obtained in the laboratory to that observed in the incident. There does not appear to have been a comparison of the effect of simulant type on the morphology of severances in fabrics and simulants, nor on the variability of simulants. This work investigates three simulants (pork, gelatine, expanded polystyrene), two knife blades (carving, bread), and how severances in the simulants and an apparel fabric typically used to manufacture T-shirts (single jersey) were affected by (i) simulant type and (ii) blade type. Severances were formed using a laboratory impact apparatus to ensure a consistent impact velocity and hence impact energy independently of the other variables. The impact velocity was chosen so that the force measured was similar to that measured in human performance trials. Force-time and energy-time curves were analysed and severance morphology (y, z directions) investigated. Simulant type and knife type significantly affected the critical forensic measurements of severance length (y direction) in the fabric and 'skin' (Tuftane). The use of EPS resulted in the lowest variability in data, further the severances recorded in both the fabric and Tuftane more accurately reflected the dimensions of the impacting knives. Copyright © 2011 Elsevier Ireland Ltd. All rights reserved.

  20. Dynamic simulation of storm-driven barrier island morphology under future sea level rise

    NASA Astrophysics Data System (ADS)

    Passeri, D. L.; Long, J.; Plant, N. G.; Bilskie, M. V.; Hagen, S. C.

    2016-12-01

    The impacts of short-term processes such as tropical and extratropical storms have the potential to alter barrier island morphology. On the event scale, the effects of storm-driven morphology may result in damage or loss of property, infrastructure and habitat. On the decadal scale, the combination of storms and sea level rise (SLR) will evolve barrier islands. The effects of SLR on hydrodynamics and coastal morphology are dynamic and inter-related; nonlinearities in SLR can cause larger peak surges, lengthier inundation times and additional inundated land, which may result in increased erosion, overwash or breaching along barrier islands. This study uses a two-dimensional morphodynamic model (XBeach) to examine the response of Dauphin Island, AL to storm surge under future SLR. The model is forced with water levels and waves provided by a large-domain hydrodynamic model. A historic validation of hurricanes Ivan and Katrina indicates the model is capable of predicting morphologic response with high skill (0.5). The validated model is used to simulate storm surge driven by Ivan and Katrina under four future SLR scenarios, ranging from 20 cm to 2 m. Each SLR scenario is implemented using a static or "bathtub" approach (in which water levels are increased linearly by the amount of SLR) versus a dynamic approach (in which SLR is applied at the open ocean boundary of the hydrodynamic model and allowed to propagate through the domain as guided by the governing equations). Results illustrate that higher amounts of SLR result in additional shoreline change, dune erosion, overwash and breaching. Compared to the dynamic approach, the static approach over-predicts inundation, dune erosion, overwash and breaching of the island. Overall, results provide a better understanding of the effects of SLR on storm-driven barrier island morphology and support a paradigm shift away from the "bathtub" approach, towards considering the integrated, dynamic effects of SLR.

  1. Event-driven time-optimal control for a class of discontinuous bioreactors.

    PubMed

    Moreno, Jaime A; Betancur, Manuel J; Buitrón, Germán; Moreno-Andrade, Iván

    2006-07-05

    Discontinuous bioreactors may be further optimized for processing inhibitory substrates using a convenient fed-batch mode. To do so the filling rate must be controlled in such a way as to push the reaction rate to its maximum value, by increasing the substrate concentration just up to the point where inhibition begins. However, an exact optimal controller requires measuring several variables (e.g., substrate concentrations in the feed and in the tank) and also good model knowledge (e.g., yield and kinetic parameters), requirements rarely satisfied in real applications. An environmentally important case, that exemplifies all these handicaps, is toxicant wastewater treatment. There the lack of online practical pollutant sensors may allow unforeseen high shock loads to be fed to the bioreactor, causing biomass inhibition that slows down the treatment process and, in extreme cases, even renders the biological process useless. In this work an event-driven time-optimal control (ED-TOC) is proposed to circumvent these limitations. We show how to detect a "there is inhibition" event by using some computable function of the available measurements. This event drives the ED-TOC to stop the filling. Later, by detecting the symmetric event, "there is no inhibition," the ED-TOC may restart the filling. A fill-react cycling then maintains the process safely hovering near its maximum reaction rate, allowing a robust and practically time-optimal operation of the bioreactor. An experimental study case of a wastewater treatment process application is presented. There the dissolved oxygen concentration was used to detect the events needed to drive the controller. (c) 2006 Wiley Periodicals, Inc.

  2. A High-Speed, Event-Driven, Active Pixel Sensor Readout for Photon-Counting Microchannel Plate Detectors

    NASA Technical Reports Server (NTRS)

    Kimble, Randy A.; Pain, Bedabrata; Norton, Timothy J.; Haas, J. Patrick; Oegerle, William R. (Technical Monitor)

    2002-01-01

    Silicon array readouts for microchannel plate intensifiers offer several attractive features. In this class of detector, the electron cloud output of the MCP intensifier is converted to visible light by a phosphor; that light is then fiber-optically coupled to the silicon array. In photon-counting mode, the resulting light splashes on the silicon array are recognized and centroided to fractional pixel accuracy by off-chip electronics. This process can result in very high (MCP-limited) spatial resolution while operating at a modest MCP gain (desirable for dynamic range and long term stability). The principal limitation of intensified CCD systems of this type is their severely limited local dynamic range, as accurate photon counting is achieved only if there are not overlapping event splashes within the frame time of the device. This problem can be ameliorated somewhat by processing events only in pre-selected windows of interest of by using an addressable charge injection device (CID) for the readout array. We are currently pursuing the development of an intriguing alternative readout concept based on using an event-driven CMOS Active Pixel Sensor. APS technology permits the incorporation of discriminator circuitry within each pixel. When coupled with suitable CMOS logic outside the array area, the discriminator circuitry can be used to trigger the readout of small sub-array windows only when and where an event splash has been detected, completely eliminating the local dynamic range problem, while achieving a high global count rate capability and maintaining high spatial resolution. We elaborate on this concept and present our progress toward implementing an event-driven APS readout.

  3. A High-Speed, Event-Driven, Active Pixel Sensor Readout for Photon-Counting Microchannel Plate Detectors

    NASA Technical Reports Server (NTRS)

    Kimble, Randy A.; Pain, B.; Norton, T. J.; Haas, P.; Fisher, Richard R. (Technical Monitor)

    2001-01-01

    Silicon array readouts for microchannel plate intensifiers offer several attractive features. In this class of detector, the electron cloud output of the MCP intensifier is converted to visible light by a phosphor; that light is then fiber-optically coupled to the silicon array. In photon-counting mode, the resulting light splashes on the silicon array are recognized and centroided to fractional pixel accuracy by off-chip electronics. This process can result in very high (MCP-limited) spatial resolution for the readout while operating at a modest MCP gain (desirable for dynamic range and long term stability). The principal limitation of intensified CCD systems of this type is their severely limited local dynamic range, as accurate photon counting is achieved only if there are not overlapping event splashes within the frame time of the device. This problem can be ameliorated somewhat by processing events only in pre-selected windows of interest or by using an addressable charge injection device (CID) for the readout array. We are currently pursuing the development of an intriguing alternative readout concept based on using an event-driven CMOS Active Pixel Sensor. APS technology permits the incorporation of discriminator circuitry within each pixel. When coupled with suitable CMOS logic outside the array area, the discriminator circuitry can be used to trigger the readout of small sub-array windows only when and where an event splash has been detected, completely eliminating the local dynamic range problem, while achieving a high global count rate capability and maintaining high spatial resolution. We elaborate on this concept and present our progress toward implementing an event-driven APS readout.

  4. Repetition-Related Reductions in Neural Activity during Emotional Simulations of Future Events.

    PubMed

    Szpunar, Karl K; Jing, Helen G; Benoit, Roland G; Schacter, Daniel L

    2015-01-01

    Simulations of future experiences are often emotionally arousing, and the tendency to repeatedly simulate negative future outcomes has been identified as a predictor of the onset of symptoms of anxiety. Nonetheless, next to nothing is known about how the healthy human brain processes repeated simulations of emotional future events. In this study, we present a paradigm that can be used to study repeated simulations of the emotional future in a manner that overcomes phenomenological confounds between positive and negative events. The results show that pulvinar nucleus and orbitofrontal cortex respectively demonstrate selective reductions in neural activity in response to frequently as compared to infrequently repeated simulations of negative and positive future events. Implications for research on repeated simulations of the emotional future in both non-clinical and clinical populations are discussed.

  5. Full body musculoskeletal model for muscle-driven simulation of human gait

    PubMed Central

    Rajagopal, Apoorva; Dembia, Christopher L.; DeMers, Matthew S.; Delp, Denny D.; Hicks, Jennifer L.; Delp, Scott L.

    2017-01-01

    Objective Musculoskeletal models provide a non-invasive means to study human movement and predict the effects of interventions on gait. Our goal was to create an open-source, three-dimensional musculoskeletal model with high-fidelity representations of the lower limb musculature of healthy young individuals that can be used to generate accurate simulations of gait. Methods Our model includes bony geometry for the full body, 37 degrees of freedom to define joint kinematics, Hill-type models of 80 muscle-tendon units actuating the lower limbs, and 17 ideal torque actuators driving the upper body. The model’s musculotendon parameters are derived from previous anatomical measurements of 21 cadaver specimens and magnetic resonance images of 24 young healthy subjects. We tested the model by evaluating its computational time and accuracy of simulations of healthy walking and running. Results Generating muscle-driven simulations of normal walking and running took approximately 10 minutes on a typical desktop computer. The differences between our muscle-generated and inverse dynamics joint moments were within 3% (RMSE) of the peak inverse dynamics joint moments in both walking and running, and our simulated muscle activity showed qualitative agreement with salient features from experimental electromyography data. Conclusion These results suggest that our model is suitable for generating muscle-driven simulations of healthy gait. We encourage other researchers to further validate and apply the model to study other motions of the lower-extremity. Significance The model is implemented in the open source software platform OpenSim. The model and data used to create and test the simulations are freely available at https://simtk.org/home/full_body/, allowing others to reproduce these results and create their own simulations. PMID:27392337

  6. Simulating adverse event spontaneous reporting systems as preferential attachment networks: application to the Vaccine Adverse Event Reporting System.

    PubMed

    Scott, J; Botsis, T; Ball, R

    2014-01-01

    Spontaneous Reporting Systems [SRS] are critical tools in the post-licensure evaluation of medical product safety. Regulatory authorities use a variety of data mining techniques to detect potential safety signals in SRS databases. Assessing the performance of such signal detection procedures requires simulated SRS databases, but simulation strategies proposed to date each have limitations. We sought to develop a novel SRS simulation strategy based on plausible mechanisms for the growth of databases over time. We developed a simulation strategy based on the network principle of preferential attachment. We demonstrated how this strategy can be used to create simulations based on specific databases of interest, and provided an example of using such simulations to compare signal detection thresholds for a popular data mining algorithm. The preferential attachment simulations were generally structurally similar to our targeted SRS database, although they had fewer nodes of very high degree. The approach was able to generate signal-free SRS simulations, as well as mimicking specific known true signals. Explorations of different reporting thresholds for the FDA Vaccine Adverse Event Reporting System suggested that using proportional reporting ratio [PRR] > 3.0 may yield better signal detection operating characteristics than the more commonly used PRR > 2.0 threshold. The network analytic approach to SRS simulation based on the principle of preferential attachment provides an attractive framework for exploring the performance of safety signal detection algorithms. This approach is potentially more principled and versatile than existing simulation approaches. The utility of network-based SRS simulations needs to be further explored by evaluating other types of simulated signals with a broader range of data mining approaches, and comparing network-based simulations with other simulation strategies where applicable.

  7. An Empirical Study of Combining Communicating Processes in a Parallel Discrete Event Simulation

    DTIC Science & Technology

    1990-12-01

    dynamics of the cost/performance criteria which typically made up computer resource acquisition decisions . offering a broad range of tradeoffs in the way... prcesses has a significant impact on simulation performance. It is the hypothesis of this 3-4 SYSTEM DECOMPOSITION PHYSICAL SYSTEM 1: N PHYSICAL PROCESS 1...EMPTY)) next-event = pop(next-event-queue); lp-clock = next-event - time; Simulate next event departure- consume event-enqueue new event end while; If no

  8. Parallel Stochastic discrete event simulation of calcium dynamics in neuron.

    PubMed

    Ishlam Patoary, Mohammad Nazrul; Tropper, Carl; McDougal, Robert A; Zhongwei, Lin; Lytton, William W

    2017-09-26

    The intra-cellular calcium signaling pathways of a neuron depends on both biochemical reactions and diffusions. Some quasi-isolated compartments (e.g. spines) are so small and calcium concentrations are so low that one extra molecule diffusing in by chance can make a nontrivial difference in its concentration (percentage-wise). These rare events can affect dynamics discretely in such way that they cannot be evaluated by a deterministic simulation. Stochastic models of such a system provide a more detailed understanding of these systems than existing deterministic models because they capture their behavior at a molecular level. Our research focuses on the development of a high performance parallel discrete event simulation environment, Neuron Time Warp (NTW), which is intended for use in the parallel simulation of stochastic reaction-diffusion systems such as intra-calcium signaling. NTW is integrated with NEURON, a simulator which is widely used within the neuroscience community. We simulate two models, a calcium buffer and a calcium wave model. The calcium buffer model is employed in order to verify the correctness and performance of NTW by comparing it to a serial deterministic simulation in NEURON. We also derived a discrete event calcium wave model from a deterministic model using the stochastic IP3R structure.

  9. Testability, Test Automation and Test Driven Development for the Trick Simulation Toolkit

    NASA Technical Reports Server (NTRS)

    Penn, John

    2014-01-01

    This paper describes the adoption of a Test Driven Development approach and a Continuous Integration System in the development of the Trick Simulation Toolkit, a generic simulation development environment for creating high fidelity training and engineering simulations at the NASA Johnson Space Center and many other NASA facilities. It describes the approach, and the significant benefits seen, such as fast, thorough and clear test feedback every time code is checked into the code repository. It also describes an approach that encourages development of code that is testable and adaptable.

  10. Acoustically Driven Magnetized Target Fusion At General Fusion: An Overview

    NASA Astrophysics Data System (ADS)

    O'Shea, Peter; Laberge, M.; Donaldson, M.; Delage, M.; the Fusion Team, General

    2016-10-01

    Magnetized Target Fusion (MTF) involves compressing an initial magnetically confined plasma of about 1e23 m-3, 100eV, 7 Tesla, 20 cm radius, >100 μsec life with a 1000x volume compression in 100 microseconds. If near adiabatic compression is achieved, the final plasma of 1e26 m-3, 10keV, 700 Tesla, 2 cm radius, confined for 10 μsec would produce interesting fusion energy gain. General Fusion (GF) is developing an acoustic compression system using pneumatic pistons focusing a shock wave on the CT plasma in the center of a 3 m diameter sphere filled with liquid lead-lithium. Low cost driver, straightforward heat extraction, good tritium breeding ratio and excellent neutron protection could lead to a practical power plant. GF (65 employees) has an active plasma R&D program including both full scale and reduced scale plasma experiments and simulation of both. Although acoustic driven compression of full scale plasmas is the end goal, present compression studies use reduced scale plasmas and chemically accelerated Aluminum liners. We will review results from our plasma target development, motivate and review the results of dynamic compression field tests and briefly describe the work to date on the acoustic driver front.

  11. Modeling the energy performance of event-driven wireless sensor network by using static sink and mobile sink.

    PubMed

    Chen, Jiehui; Salim, Mariam B; Matsumoto, Mitsuji

    2010-01-01

    Wireless Sensor Networks (WSNs) designed for mission-critical applications suffer from limited sensing capacities, particularly fast energy depletion. Regarding this, mobile sinks can be used to balance the energy consumption in WSNs, but the frequent location updates of the mobile sinks can lead to data collisions and rapid energy consumption for some specific sensors. This paper explores an optimal barrier coverage based sensor deployment for event driven WSNs where a dual-sink model was designed to evaluate the energy performance of not only static sensors, but Static Sink (SS) and Mobile Sinks (MSs) simultaneously, based on parameters such as sensor transmission range r and the velocity of the mobile sink v, etc. Moreover, a MS mobility model was developed to enable SS and MSs to effectively collaborate, while achieving spatiotemporal energy performance efficiency by using the knowledge of the cumulative density function (cdf), Poisson process and M/G/1 queue. The simulation results verified that the improved energy performance of the whole network was demonstrated clearly and our eDSA algorithm is more efficient than the static-sink model, reducing energy consumption approximately in half. Moreover, we demonstrate that our results are robust to realistic sensing models and also validate the correctness of our results through extensive simulations.

  12. Modeling the Energy Performance of Event-Driven Wireless Sensor Network by Using Static Sink and Mobile Sink

    PubMed Central

    Chen, Jiehui; Salim, Mariam B.; Matsumoto, Mitsuji

    2010-01-01

    Wireless Sensor Networks (WSNs) designed for mission-critical applications suffer from limited sensing capacities, particularly fast energy depletion. Regarding this, mobile sinks can be used to balance the energy consumption in WSNs, but the frequent location updates of the mobile sinks can lead to data collisions and rapid energy consumption for some specific sensors. This paper explores an optimal barrier coverage based sensor deployment for event driven WSNs where a dual-sink model was designed to evaluate the energy performance of not only static sensors, but Static Sink (SS) and Mobile Sinks (MSs) simultaneously, based on parameters such as sensor transmission range r and the velocity of the mobile sink v, etc. Moreover, a MS mobility model was developed to enable SS and MSs to effectively collaborate, while achieving spatiotemporal energy performance efficiency by using the knowledge of the cumulative density function (cdf), Poisson process and M/G/1 queue. The simulation results verified that the improved energy performance of the whole network was demonstrated clearly and our eDSA algorithm is more efficient than the static-sink model, reducing energy consumption approximately in half. Moreover, we demonstrate that our results are robust to realistic sensing models and also validate the correctness of our results through extensive simulations. PMID:22163503

  13. Discrete Element Simulations of Density-Driven Volcanic Deformation: Applications to Martian Caldera Complexes

    NASA Astrophysics Data System (ADS)

    Zivney, L. L.; Morgan, J. K.; McGovern, P. J.

    2009-12-01

    We have carried out 2-D numerical simulations using the discrete element method (DEM) to investigate density-driven deformation in Martian volcanic edifices. Our initial simulations demonstrated that gravitationally-driven settling of a dense, ductile cumulate body within a volcano causes enhanced lateral spreading of the edifice flanks, influencing the overall volcano morphology and generating pronounced summit subsidence. Here, we explore the effects of cumulate bodies and their geometries on the generation of summit calderas, to gain insight into the origin of Martian caldera complexes, in particular the Olympus Mons and Arsia Mons calderas. The Olympus Mons caldera, roughly 80 km in diameter, is composed of several small over-lapping craters with steep walls, thought to be produced by episodic collapse events of multiple shallow magma chambers. The Arsia Mons caldera spans ~130 km across and displays one prominent crater with gently sloping margins, possibly reflecting the collapse of a single magma chamber. Although the depth of the magma chamber is debated, its lateral width is thought to approximate the diameter of the caldera. Our models indicate that cumulate bodies located at shallow depths of <10 km below the edifice surface produce caldera complexes on the order of 80-100 km in width, with increasing cumulate widths producing widening calderas. Narrow cumulate bodies with densities near 4000 kg/m3 produce the deepest calderas (up to ~8 km deep). We conclude that the generation of large Arsia-type calderas may be adequately modeled by the presence of a wide cumulate body found at shallow depths beneath the summit. Although we do not model the multiple magma chamber systems thought to exist beneath the Olympus Mons summit, the closely spaced craters and the small size of the caldera relative to the size of the volcano (~13% of the edifice) suggests that the cumulate body would be narrow; our simulations of a single narrow cumulate body are capable of

  14. WRF simulation of downslope wind events in coastal Santa Barbara County

    NASA Astrophysics Data System (ADS)

    Cannon, Forest; Carvalho, Leila M. V.; Jones, Charles; Hall, Todd; Gomberg, David; Dumas, John; Jackson, Mark

    2017-07-01

    The National Weather Service (NWS) considers frequent gusty downslope winds, accompanied by rapid warming and decreased relative humidity, among the most significant weather events affecting southern California coastal areas in the vicinity of Santa Barbara (SB). These extreme conditions, commonly known as "sundowners", have affected the evolution of all major wildfires that impacted SB in recent years. Sundowners greatly increase fire, aviation and maritime navigation hazards and are thus a priority for regional forecasting. Currently, the NWS employs the Weather Research Forecasting (WRF) model at 2 km resolution to complement forecasts at regional-to-local scales. However, no systematic study has been performed to evaluate the skill of WRF in simulating sundowners. This research presents a case study of an 11-day period in spring 2004 during which sundowner events were observed on multiple nights. We perform sensitivity experiments for WRF using available observations for validation and demonstrate that WRF is skillful in representing the general mesoscale structure of these events, though important shortcomings exist. Furthermore, we discuss the generation and evolution of sundowners during the case study using the best performing configuration, and compare these results to hindcasts for two major SB fires. Unique, but similar, profiles of wind and stability are observed over SB between case studies despite considerable differences in large-scale circulation, indicating that common conditions may exist across all events. These findings aid in understanding the evolution of sundowner events and are potentially valuable for event prediction.

  15. Driven fragmentation of granular gases.

    PubMed

    Cruz Hidalgo, Raúl; Pagonabarraga, Ignacio

    2008-06-01

    The dynamics of homogeneously heated granular gases which fragment due to particle collisions is analyzed. We introduce a kinetic model which accounts for correlations induced at the grain collisions and analyze both the kinetics and relevant distribution functions these systems develop. The work combines analytical and numerical studies based on direct simulation Monte Carlo calculations. A broad family of fragmentation probabilities is considered, and its implications for the system kinetics are discussed. We show that generically these driven materials evolve asymptotically into a dynamical scaling regime. If the fragmentation probability tends to a constant, the grain number diverges at a finite time, leading to a shattering singularity. If the fragmentation probability vanishes, then the number of grains grows monotonously as a power law. We consider different homogeneous thermostats and show that the kinetics of these systems depends weakly on both the grain inelasticity and driving. We observe that fragmentation plays a relevant role in the shape of the velocity distribution of the particles. When the fragmentation is driven by local stochastic events, the long velocity tail is essentially exponential independently of the heating frequency and the breaking rule. However, for a Lowe-Andersen thermostat, numerical evidence strongly supports the conjecture that the scaled velocity distribution follows a generalized exponential behavior f(c) approximately exp(-cn) , with n approximately 1.2 , regarding less the fragmentation mechanisms.

  16. Modeling Anti-Air Warfare With Discrete Event Simulation and Analyzing Naval Convoy Operations

    DTIC Science & Technology

    2016-06-01

    WARFARE WITH DISCRETE EVENT SIMULATION AND ANALYZING NAVAL CONVOY OPERATIONS by Ali E. Opcin June 2016 Thesis Advisor: Arnold H. Buss Co...REPORT DATE June 2016 3. REPORT TYPE AND DATES COVERED Master’s thesis 4. TITLE AND SUBTITLE MODELING ANTI-AIR WARFARE WITH DISCRETE EVENT...In this study, a discrete event simulation (DES) was built by modeling ships, and their sensors and weapons, to simulate convoy operations under

  17. El Nino - La Nina events simulated with Cane and Zebiak`s model and observed with satellite or in situ data. Part I: Model data comparison

    DOE Office of Scientific and Technical Information (OSTI.GOV)

    Perigaud C.; Dewitte, B.

    The Zebiak and Cane model is used in its {open_quotes}uncoupled mode,{close_quotes} meaning that the oceanic model component is driven by the Florida State University (FSU) wind stress anomalies over 1980-93 to simulate sea surface temperature anomalies, and these are used in the atmospheric model component to generate wind anomalies. Simulations are compared with data derived from FSU winds, International Satellite Cloud Climatology Project cloud convection, Advanced Very High Resolution Radiometer SST, Geosat sea level, 20{degrees}C isotherm depth derived from an expendable bathythermograph, and current velocities estimated from drifters or current-meter moorings. Forced by the simulated SST, the atmospheric model ismore » fairly successful in reproducing the observed westerlies during El Nino events. The model fails to simulate the easterlies during La Nina 1988. The simulated forcing of the atmosphere is in very poor agreement with the heating derived from cloud convection data. Similarly, the model is fairly successful in reproducing the warm anomalies during El Nino events. However, it fails to simulate the observed cold anomalies. Simulated variations of thermocline depth agree reasonably well with observations. The model simulates zonal current anomalies that are reversing at a dominant 9-month frequency. Projecting altimetric observations on Kelvin and Rossby waves provides an estimate of zonal current anomalies, which is consistent with the ones derived from drifters or from current meter moorings. Unlike the simulated ones, the observed zonal current anomalies reverse from eastward during El Nino events to westward during La Nina events. The simulated 9-month oscillations correspond to a resonant mode of the basin. They can be suppressed by cancelling the wave reflection at the boundaries, or they can be attenuated by increasing the friction in the ocean model. 58 refs., 14 figs., 6 tabs.« less

  18. Visual Data-Analytics of Large-Scale Parallel Discrete-Event Simulations

    DOE Office of Scientific and Technical Information (OSTI.GOV)

    Ross, Caitlin; Carothers, Christopher D.; Mubarak, Misbah

    Parallel discrete-event simulation (PDES) is an important tool in the codesign of extreme-scale systems because PDES provides a cost-effective way to evaluate designs of highperformance computing systems. Optimistic synchronization algorithms for PDES, such as Time Warp, allow events to be processed without global synchronization among the processing elements. A rollback mechanism is provided when events are processed out of timestamp order. Although optimistic synchronization protocols enable the scalability of large-scale PDES, the performance of the simulations must be tuned to reduce the number of rollbacks and provide an improved simulation runtime. To enable efficient large-scale optimistic simulations, one has tomore » gain insight into the factors that affect the rollback behavior and simulation performance. We developed a tool for ROSS model developers that gives them detailed metrics on the performance of their large-scale optimistic simulations at varying levels of simulation granularity. Model developers can use this information for parameter tuning of optimistic simulations in order to achieve better runtime and fewer rollbacks. In this work, we instrument the ROSS optimistic PDES framework to gather detailed statistics about the simulation engine. We have also developed an interactive visualization interface that uses the data collected by the ROSS instrumentation to understand the underlying behavior of the simulation engine. The interface connects real time to virtual time in the simulation and provides the ability to view simulation data at different granularities. We demonstrate the usefulness of our framework by performing a visual analysis of the dragonfly network topology model provided by the CODES simulation framework built on top of ROSS. The instrumentation needs to minimize overhead in order to accurately collect data about the simulation performance. To ensure that the instrumentation does not introduce unnecessary overhead, we perform

  19. Mass imbalances in EPANET water-quality simulations

    DOE Office of Scientific and Technical Information (OSTI.GOV)

    Davis, Michael J.; Janke, Robert; Taxon, Thomas N.

    EPANET is widely employed to simulate water quality in water distribution systems. However, the time-driven simulation approach used to determine concentrations of water-quality constituents provides accurate results, in general, only for small water-quality time steps; use of an adequately short time step may not be feasible. Overly long time steps can yield errors in concentrations and result in situations in which constituent mass is not conserved. Mass may not be conserved even when EPANET gives no errors or warnings. This paper explains how such imbalances can occur and provides examples of such cases; it also presents a preliminary event-driven approachmore » that conserves mass with a water-quality time step that is as long as the hydraulic time step. Results obtained using the current approach converge, or tend to converge, to those obtained using the new approach as the water-quality time step decreases. Improving the water-quality routing algorithm used in EPANET could eliminate mass imbalances and related errors in estimated concentrations.« less

  20. Integrated hydraulic and organophosphate pesticide injection simulations for enhancing event detection in water distribution systems.

    PubMed

    Schwartz, Rafi; Lahav, Ori; Ostfeld, Avi

    2014-10-15

    As a complementary step towards solving the general event detection problem of water distribution systems, injection of the organophosphate pesticides, chlorpyrifos (CP) and parathion (PA), were simulated at various locations within example networks and hydraulic parameters were calculated over 24-h duration. The uniqueness of this study is that the chemical reactions and byproducts of the contaminants' oxidation were also simulated, as well as other indicative water quality parameters such as alkalinity, acidity, pH and the total concentration of free chlorine species. The information on the change in water quality parameters induced by the contaminant injection may facilitate on-line detection of an actual event involving this specific substance and pave the way to development of a generic methodology for detecting events involving introduction of pesticides into water distribution systems. Simulation of the contaminant injection was performed at several nodes within two different networks. For each injection, concentrations of the relevant contaminants' mother and daughter species, free chlorine species and water quality parameters, were simulated at nodes downstream of the injection location. The results indicate that injection of these substances can be detected at certain conditions by a very rapid drop in Cl2, functioning as the indicative parameter, as well as a drop in alkalinity concentration and a small decrease in pH, both functioning as supporting parameters, whose usage may reduce false positive alarms. Copyright © 2014 Elsevier Ltd. All rights reserved.

  1. Optical eye simulator for laser dazzle events.

    PubMed

    Coelho, João M P; Freitas, José; Williamson, Craig A

    2016-03-20

    An optical simulator of the human eye and its application to laser dazzle events are presented. The simulator combines optical design software (ZEMAX) with a scientific programming language (MATLAB) and allows the user to implement and analyze a dazzle scenario using practical, real-world parameters. Contrary to conventional analytical glare analysis, this work uses ray tracing and the scattering model and parameters for each optical element of the eye. The theoretical background of each such element is presented in relation to the model. The overall simulator's calibration, validation, and performance analysis are achieved by comparison with a simpler model based uponCIE disability glare data. Results demonstrate that this kind of advanced optical eye simulation can be used to represent laser dazzle and has the potential to extend the range of applicability of analytical models.

  2. Network-based simulation of aircraft at gates in airport terminals

    DOE Office of Scientific and Technical Information (OSTI.GOV)

    Cheng, Y.

    1998-03-01

    Simulation is becoming an essential tool for planning, design, and management of airport facilities. A simulation of aircraft at gates at an airport can be applied for various periodically performed applications, relating to the dynamic behavior of aircraft at gates in airport terminals for analyses, evaluations, and decision supports. Conventionally, such simulations are implemented using an event-driven method. For a more efficient simulation, this paper proposes a network-based method. The basic idea is to transform all the sequence constraint relations of aircraft at gates into a network. The simulation is done by calculating the longest path to all the nodesmore » in the network. The effect of the algorithm of the proposed method has been examined by experiments, and the superiority of the proposed method over the event-driven method is revealed through comprehensive comparisons of their overall simulation performance.« less

  3. Generalized Detectability for Discrete Event Systems

    PubMed Central

    Shu, Shaolong; Lin, Feng

    2011-01-01

    In our previous work, we investigated detectability of discrete event systems, which is defined as the ability to determine the current and subsequent states of a system based on observation. For different applications, we defined four types of detectabilities: (weak) detectability, strong detectability, (weak) periodic detectability, and strong periodic detectability. In this paper, we extend our results in three aspects. (1) We extend detectability from deterministic systems to nondeterministic systems. Such a generalization is necessary because there are many systems that need to be modeled as nondeterministic discrete event systems. (2) We develop polynomial algorithms to check strong detectability. The previous algorithms are based on observer whose construction is of exponential complexity, while the new algorithms are based on a new automaton called detector. (3) We extend detectability to D-detectability. While detectability requires determining the exact state of a system, D-detectability relaxes this requirement by asking only to distinguish certain pairs of states. With these extensions, the theory on detectability of discrete event systems becomes more applicable in solving many practical problems. PMID:21691432

  4. Simulating Supernovae Driven Outflows in Dwarf Galaxies

    NASA Astrophysics Data System (ADS)

    Rodriguez, Jaimee-Ian

    2018-01-01

    Galactic outflows, or winds, prove to be a necessary input for galactic simulations to produce results comparable to observation, for it solves issues caused by what previous literature dubbed the “angular momentum catastrophe.” While it is known that the nature of outflows depends on the nature of the Interstellar Medium (ISM), the mechanisms behind outflows are still not completely understood. We investigate the driving force behind galactic outflows and the factors that influence their behavior, hypothesizing that supernovae within the galaxy drive these winds. We study isolated, high-resolution, smooth particle hydrodynamic simulations, focusing specifically on dwarf galaxies due to their shallow potential wells, which allow for more significant outflows. We find that outflows follow star formation (and associated supernovae) suggesting the causal relationship between the two. Furthermore, simulations with higher diffusivity differ little in star formation rate, but show significantly lower outflow rates, suggesting that environmental factors that have little effect on regulating star formation can greatly influence outflows, and so efficient outflows can be driven by a constant rate of supernovae, depending on ISM behavior. We are currently analyzing disk morphology and ambient density in order to comprehend the effect of supernovae on the immediate interstellar gas. By attaining greater understanding of the origin of galactic outflows, we will be able to not only improve the accuracy of simulations, we will also be able to gain greater insight into galactic formation and evolution, as outflows and resultant inflows may be vital to the regulation of galaxies throughout their lifetimes.

  5. Conceptual and perceptual encoding instructions differently affect event recall.

    PubMed

    García-Bajos, Elvira; Migueles, Malen; Aizpurua, Alaitz

    2014-11-01

    When recalling an event, people usually retrieve the main facts and a reduced proportion of specific details. The objective of this experiment was to study the effects of conceptually and perceptually driven encoding in the recall of conceptual and perceptual information of an event. The materials selected for the experiment were two movie trailers. To enhance the encoding instructions, after watching the first trailer participants answered conceptual or perceptual questions about the event, while a control group answered general knowledge questions. After watching the second trailer, all of the participants completed a closed-ended recall task consisting of conceptual and perceptual items. Conceptual information was better recalled than perceptual details and participants made more perceptual than conceptual commission errors. Conceptually driven processing enhanced the recall of conceptual information, while perceptually driven processing not only did not improve the recall of descriptive details, but also damaged the standard conceptual/perceptual recall relationship.

  6. Preschoolers can infer general rules governing fantastical events in fiction.

    PubMed

    Van de Vondervoort, Julia W; Friedman, Ori

    2014-05-01

    Young children are frequently exposed to fantastic fiction. How do they make sense of the unrealistic and impossible events that occur in such fiction? Although children could view such events as isolated episodes, the present experiments suggest that children use such events to infer general fantasy rules. In 2 experiments, 2- to 4-year-olds were shown scenarios in which 2 animals behaved unrealistically (N = 78 in Experiment 1, N = 94 in Experiment 2). When asked to predict how other animals in the fiction would behave, children predicted novel behaviors consistent with the nature of the fiction. These findings suggest that preschoolers can infer the general rules that govern the events and entities in fantastic fiction and can use these rules to predict what events will happen in the fiction. The findings also provide evidence that children may infer fantasy rules at a more superordinate level than the basic level. (PsycINFO Database Record (c) 2014 APA, all rights reserved).

  7. Multirate and event-driven Kalman filters for helicopter flight

    NASA Technical Reports Server (NTRS)

    Sridhar, Banavar; Smith, Phillip; Suorsa, Raymond E.; Hussien, Bassam

    1993-01-01

    A vision-based obstacle detection system that provides information about objects as a function of azimuth and elevation is discussed. The range map is computed using a sequence of images from a passive sensor, and an extended Kalman filter is used to estimate range to obstacles. The magnitude of the optical flow that provides measurements for each Kalman filter varies significantly over the image depending on the helicopter motion and object location. In a standard Kalman filter, the measurement update takes place at fixed intervals. It may be necessary to use a different measurement update rate in different parts of the image in order to maintain the same signal to noise ratio in the optical flow calculations. A range estimation scheme that accepts the measurement only under certain conditions is presented. The estimation results from the standard Kalman filter are compared with results from a multirate Kalman filter and an event-driven Kalman filter for a sequence of helicopter flight images.

  8. Start-to-end simulation of the shot-noise driven microbunching instability experiment at the Linac Coherent Light Source

    DOE Office of Scientific and Technical Information (OSTI.GOV)

    Qiang, J.; Ding, Y.; Emma, P.

    The shot-noise driven microbunching instability can significantly degrade electron beam quality in x-ray free electron laser light sources. Experiments were carried out at the Linac Coherent Light Source (LCLS) to study this instability. Here in this paper, we present start-to-end simulations of the shot-noise driven microbunching instability experiment at the LCLS using the real number of electrons. The simulation results reproduce the measurements quite well. A microbunching self-heating mechanism is also illustrated in the simulation, which helps explain the experimental observation.

  9. Start-to-end simulation of the shot-noise driven microbunching instability experiment at the Linac Coherent Light Source

    DOE PAGES

    Qiang, J.; Ding, Y.; Emma, P.; ...

    2017-05-23

    The shot-noise driven microbunching instability can significantly degrade electron beam quality in x-ray free electron laser light sources. Experiments were carried out at the Linac Coherent Light Source (LCLS) to study this instability. Here in this paper, we present start-to-end simulations of the shot-noise driven microbunching instability experiment at the LCLS using the real number of electrons. The simulation results reproduce the measurements quite well. A microbunching self-heating mechanism is also illustrated in the simulation, which helps explain the experimental observation.

  10. Molecular Dynamics Simulations of an Idealized Shock Tube: N2 in Ar Bath Driven by He

    NASA Astrophysics Data System (ADS)

    Piskulich, Ezekiel Ashe; Sewell, Thomas D.; Thompson, Donald L.

    2015-06-01

    The dynamics of 10% N2 in Ar initially at 298 K in an idealized shock tube driven by He was studied using molecular dynamics. The simulations were performed using the Large-Scale Atomic/Molecular Massively Parallel Simulator (LAMMPS) code. Nitrogen was modeled as a Morse oscillator and non-covalent interactions were approximated by the Buckingham exponential-6 pair potential. The initial pressures in the He driver gas and the driven N2/Ar gas were 1000 atm and 20 atm, respectively. Microcanonical trajectories were followed for 2 ns following release of the driver gas. Results for excitation and subsequent relaxation of the N2, as well as properties of the gas during the simulations, will be reported.

  11. Preschoolers Can Infer General Rules Governing Fantastical Events in Fiction

    ERIC Educational Resources Information Center

    Van de Vondervoort, Julia W.; Friedman, Ori

    2014-01-01

    Young children are frequently exposed to fantastic fiction. How do they make sense of the unrealistic and impossible events that occur in such fiction? Although children could view such events as isolated episodes, the present experiments suggest that children use such events to infer general fantasy rules. In 2 experiments, 2-to 4-year-olds were…

  12. ATLAS EventIndex general dataflow and monitoring infrastructure

    NASA Astrophysics Data System (ADS)

    Fernández Casaní, Á.; Barberis, D.; Favareto, A.; García Montoro, C.; González de la Hoz, S.; Hřivnáč, J.; Prokoshin, F.; Salt, J.; Sánchez, J.; Többicke, R.; Yuan, R.; ATLAS Collaboration

    2017-10-01

    The ATLAS EventIndex has been running in production since mid-2015, reliably collecting information worldwide about all produced events and storing them in a central Hadoop infrastructure at CERN. A subset of this information is copied to an Oracle relational database for fast dataset discovery, event-picking, crosschecks with other ATLAS systems and checks for event duplication. The system design and its optimization is serving event picking from requests of a few events up to scales of tens of thousand of events, and in addition, data consistency checks are performed for large production campaigns. Detecting duplicate events with a scope of physics collections has recently arisen as an important use case. This paper describes the general architecture of the project and the data flow and operation issues, which are addressed by recent developments to improve the throughput of the overall system. In this direction, the data collection system is reducing the usage of the messaging infrastructure to overcome the performance shortcomings detected during production peaks; an object storage approach is instead used to convey the event index information, and messages to signal their location and status. Recent changes in the Producer/Consumer architecture are also presented in detail, as well as the monitoring infrastructure.

  13. MHD simulation of the Bastille day event

    DOE Office of Scientific and Technical Information (OSTI.GOV)

    Linker, Jon, E-mail: linkerj@predsci.com; Torok, Tibor; Downs, Cooper

    2016-03-25

    We describe a time-dependent, thermodynamic, three-dimensional MHD simulation of the July 14, 2000 coronal mass ejection (CME) and flare. The simulation starts with a background corona developed using an MDI-derived magnetic map for the boundary condition. Flux ropes using the modified Titov-Demoulin (TDm) model are used to energize the pre-event active region, which is then destabilized by photospheric flows that cancel flux near the polarity inversion line. More than 10{sup 33} ergs are impulsively released in the simulated eruption, driving a CME at 1500 km/s, close to the observed speed of 1700km/s. The post-flare emission in the simulation is morphologically similarmore » to the observed post-flare loops. The resulting flux rope that propagates to 1 AU is similar in character to the flux rope observed at 1 AU, but the simulated ICME center passes 15° north of Earth.« less

  14. An Overview of Importance Splitting for Rare Event Simulation

    ERIC Educational Resources Information Center

    Morio, Jerome; Pastel, Rudy; Le Gland, Francois

    2010-01-01

    Monte Carlo simulations are a classical tool to analyse physical systems. When unlikely events are to be simulated, the importance sampling technique is often used instead of Monte Carlo. Importance sampling has some drawbacks when the problem dimensionality is high or when the optimal importance sampling density is complex to obtain. In this…

  15. The temporal evolution of explosive events and its implication on reconnection dynamics

    NASA Astrophysics Data System (ADS)

    Guo, L.; Liu, W.; De Pontieu, B.; Huang, Y. M.; Peter, H.; Bhattacharjee, A.

    2017-12-01

    Transition-region explosive events and other bursts seen in extreme UV light are characterized by broad spectral line profiles, and the more violent ones show a strong enhancement of emission. They are thought to be driven by magnetic reconnection, because of their characteristic spectral profiles often indicating strong Alfvénic flows, and because of the fact that they typically occur where magnetic flux concentrations of opposite polarity intersect. In this presentation, we will focus on the temporal evolution of transition-region explosive events. In particular, we will investigate fast onsets of these events and the rapid oscillations of intensity during these event. The fast onset refers to the beginning of an explosive event, where the intensities and the widths of its line profiles increase dramatically (often within less than 10 seconds) and the rapid oscillations of intensity refer to blinks of emission that usually last less than 10 seconds during the event. In order to interpret and understand underlying mechanisms of these observations, we conduct numerical simulation of an explosive event and calculate its spectra. We observe a similar temporal evolution in the synthetic Si IV spectra when the explosive event is driven by time-dependent reconnection—plasmoid instability. The qualitative agreement between observations and simulations suggests that the temporal evolution of Si IV spectra of explosive events are closely related to reconnection dynamics.

  16. Internally driven inertial waves in geodynamo simulations

    NASA Astrophysics Data System (ADS)

    Ranjan, A.; Davidson, P. A.; Christensen, U. R.; Wicht, J.

    2018-05-01

    Inertial waves are oscillations in a rotating fluid, such as the Earth's outer core, which result from the restoring action of the Coriolis force. In an earlier work, it was argued by Davidson that inertial waves launched near the equatorial regions could be important for the α2 dynamo mechanism, as they can maintain a helicity distribution which is negative (positive) in the north (south). Here, we identify such internally driven inertial waves, triggered by buoyant anomalies in the equatorial regions in a strongly forced geodynamo simulation. Using the time derivative of vertical velocity, ∂uz/∂t, as a diagnostic for traveling wave fronts, we find that the horizontal movement in the buoyancy field near the equator is well correlated with a corresponding movement of the fluid far from the equator. Moreover, the azimuthally averaged spectrum of ∂uz/∂t lies in the inertial wave frequency range. We also test the dispersion properties of the waves by computing the spectral energy as a function of frequency, ϖ, and the dispersion angle, θ. Our results suggest that the columnar flow in the rotation-dominated core, which is an important ingredient for the maintenance of a dipolar magnetic field, is maintained despite the chaotic evolution of the buoyancy field on a fast timescale by internally driven inertial waves.

  17. Episodic simulation of future events is impaired in mild Alzheimer's disease

    PubMed Central

    Addis, Donna Rose; Sacchetti, Daniel C.; Ally, Brandon A.; Budson, Andrew E.; Schacter, Daniel L.

    2009-01-01

    Recent neuroimaging studies have demonstrated that both remembering the past and simulating the future activate a core neural network including the medial temporal lobes. Regions of this network, in particular the medial temporal lobes, are prime sites for amyloid deposition and are structurally and functionally compromised in Alzheimer's disease (AD). While we know some functions of this core network, specifically episodic autobiographical memory, are impaired in AD, no study has examined whether future episodic simulation is similarly impaired. We tested the ability of sixteen AD patients and sixteen age-matched controls to generate past and future autobiographical events using an adapted version of the Autobiographical Interview. Participants also generated five remote autobiographical memories from across the lifespan. Event transcriptions were segmented into distinct details, classified as either internal (episodic) or external (non-episodic). AD patients exhibited deficits in both remembering past events and simulating future events, generating fewer internal and external episodic details than healthy older controls. The internal and external detail scores were strongly correlated across past and future events, providing further evidence of the close linkages between the mental representations of past and future. PMID:19497331

  18. Event-Driven Simulation and Analysis of an Underwater Acoustic Local Area Network

    DTIC Science & Technology

    2010-06-01

    Successful number of data packets % b. PSUP = Successful number of Utility packets % c. PSB = Successful number of byte Tx. % d. PSPRT = Number of sub...g. PFU = Number of failed utilities Tx failures with time log of failure % h. PTO = Number of Time-outs 55 function [PSDP,PSUP, PSB ,PSPRT,PFP,PFSP...transmitted PSB = 0 ; % Number of Bytes transmitted PSPRT = 0; % Number of sub-packets retransmitted PFP = 0; % Number of failed packets event PFSP

  19. Developing a preliminary 'never event' list for general practice using consensus-building methods.

    PubMed

    de Wet, Carl; O'Donnell, Catherine; Bowie, Paul

    2014-03-01

    The 'never event' concept has been implemented in many acute hospital settings to help prevent serious patient safety incidents. Benefits include increasing awareness of highly important patient safety risks among the healthcare workforce, promoting proactive implementation of preventive measures, and facilitating incident reporting. To develop a preliminary list of never events for general practice. Application of a range of consensus-building methods in Scottish and UK general practices. A total of 345 general practice team members suggested potential never events. Next, 'informed' staff (n =15) developed criteria for defining never events and applied the criteria to create a list of candidate never events. Finally, UK primary care patient safety 'experts' (n = 17) reviewed, refined, and validated a preliminary list via a modified Delphi group and by completing a content validity index exercise. There were 721 written suggestions received as potential never events. Thematic categorisation reduced this to 38. Five criteria specific to general practice were developed and applied to produce 11 candidate never events. The expert group endorsed a preliminary list of 10 items with a content validity index (CVI) score of >80%. A preliminary list of never events was developed for general practice through practitioner experience and consensus-building methods. This is an important first step to determine the potential value of the never event concept in this setting. It is now intended to undertake further testing of this preliminary list to assess its acceptability, feasibility, and potential usefulness as a safety improvement intervention.

  20. Regional Evaluation of the Severity-Based Stroke Triage Algorithm for Emergency Medical Services Using Discrete Event Simulation.

    PubMed

    Bogle, Brittany M; Asimos, Andrew W; Rosamond, Wayne D

    2017-10-01

    The Severity-Based Stroke Triage Algorithm for Emergency Medical Services endorses routing patients with suspected large vessel occlusion acute ischemic strokes directly to endovascular stroke centers (ESCs). We sought to evaluate different specifications of this algorithm within a region. We developed a discrete event simulation environment to model patients with suspected stroke transported according to algorithm specifications, which varied by stroke severity screen and permissible additional transport time for routing patients to ESCs. We simulated King County, Washington, and Mecklenburg County, North Carolina, distributing patients geographically into census tracts. Transport time to the nearest hospital and ESC was estimated using traffic-based travel times. We assessed undertriage, overtriage, transport time, and the number-needed-to-route, defined as the number of patients enduring additional transport to route one large vessel occlusion patient to an ESC. Undertriage was higher and overtriage was lower in King County compared with Mecklenburg County for each specification. Overtriage variation was primarily driven by screen (eg, 13%-55% in Mecklenburg County and 10%-40% in King County). Transportation time specifications beyond 20 minutes increased overtriage and decreased undertriage in King County but not Mecklenburg County. A low- versus high-specificity screen routed 3.7× more patients to ESCs. Emergency medical services spent nearly twice the time routing patients to ESCs in King County compared with Mecklenburg County. Our results demonstrate how discrete event simulation can facilitate informed decision making to optimize emergency medical services stroke severity-based triage algorithms. This is the first step toward developing a mature simulation to predict patient outcomes. © 2017 American Heart Association, Inc.

  1. Automatic CT simulation optimization for radiation therapy: A general strategy.

    PubMed

    Li, Hua; Yu, Lifeng; Anastasio, Mark A; Chen, Hsin-Chen; Tan, Jun; Gay, Hiram; Michalski, Jeff M; Low, Daniel A; Mutic, Sasa

    2014-03-01

    In radiation therapy, x-ray computed tomography (CT) simulation protocol specifications should be driven by the treatment planning requirements in lieu of duplicating diagnostic CT screening protocols. The purpose of this study was to develop a general strategy that allows for automatically, prospectively, and objectively determining the optimal patient-specific CT simulation protocols based on radiation-therapy goals, namely, maintenance of contouring quality and integrity while minimizing patient CT simulation dose. The authors proposed a general prediction strategy that provides automatic optimal CT simulation protocol selection as a function of patient size and treatment planning task. The optimal protocol is the one that delivers the minimum dose required to provide a CT simulation scan that yields accurate contours. Accurate treatment plans depend on accurate contours in order to conform the dose to actual tumor and normal organ positions. An image quality index, defined to characterize how simulation scan quality affects contour delineation, was developed and used to benchmark the contouring accuracy and treatment plan quality within the predication strategy. A clinical workflow was developed to select the optimal CT simulation protocols incorporating patient size, target delineation, and radiation dose efficiency. An experimental study using an anthropomorphic pelvis phantom with added-bolus layers was used to demonstrate how the proposed prediction strategy could be implemented and how the optimal CT simulation protocols could be selected for prostate cancer patients based on patient size and treatment planning task. Clinical IMRT prostate treatment plans for seven CT scans with varied image quality indices were separately optimized and compared to verify the trace of target and organ dosimetry coverage. Based on the phantom study, the optimal image quality index for accurate manual prostate contouring was 4.4. The optimal tube potentials for patient sizes

  2. GRMHD Simulations of Visibility Amplitude Variability for Event Horizon Telescope Images of Sgr A*

    NASA Astrophysics Data System (ADS)

    Medeiros, Lia; Chan, Chi-kwan; Özel, Feryal; Psaltis, Dimitrios; Kim, Junhan; Marrone, Daniel P.; Sa¸dowski, Aleksander

    2018-04-01

    The Event Horizon Telescope will generate horizon scale images of the black hole in the center of the Milky Way, Sgr A*. Image reconstruction using interferometric visibilities rests on the assumption of a stationary image. We explore the limitations of this assumption using high-cadence disk- and jet-dominated GRMHD simulations of Sgr A*. We also employ analytic models that capture the basic characteristics of the images to understand the origin of the variability in the simulated visibility amplitudes. We find that, in all simulations, the visibility amplitudes for baselines oriented parallel and perpendicular to the spin axis of the black hole follow general trends that do not depend strongly on accretion-flow properties. This suggests that fitting Event Horizon Telescope observations with simple geometric models may lead to a reasonably accurate determination of the orientation of the black hole on the plane of the sky. However, in the disk-dominated models, the locations and depths of the minima in the visibility amplitudes are highly variable and are not related simply to the size of the black hole shadow. This suggests that using time-independent models to infer additional black hole parameters, such as the shadow size or the spin magnitude, will be severely affected by the variability of the accretion flow.

  3. A current-driven resistive instability and its nonlinear effects in simulations of coaxial helicity injection in a tokamak

    DOE PAGES

    Hooper, E. B.; Sovinec, C. R.

    2016-10-06

    An instability observed in whole-device, resistive magnetohydrodynamic simulations of the driven phase of coaxial helicity injection in the National Spherical Torus eXperiment is identified as a current-driven resistive mode in an unusual geometry that transiently generates a current sheet. The mode consists of plasma flow velocity and magnetic field eddies in a tube aligned with the magnetic field at the surface of the injected magnetic flux. At low plasma temperatures (~10–20 eV), the mode is benign, but at high temperatures (~100 eV) its amplitude undergoes relaxation oscillations, broadening the layer of injected current and flow at the surface of themore » injected toroidal flux and background plasma. The poloidal-field structure is affected and the magnetic surface closure is generally prevented while the mode undergoes relaxation oscillations during injection. Furthermore, this study describes the mode and uses linearized numerical computations and an analytic slab model to identify the unstable mode.« less

  4. Simulations of Radiation-Driven Shock Wave Experiments

    NASA Astrophysics Data System (ADS)

    Dukart, R. J.; Asay, J. R.; Porter, J. L.; Matzen, M. K.

    1997-07-01

    For inertial confinement fusion (I.C.F.) target design, we need to understand material properties between 1- and 150-Mbar pressure. In this presentation we will show that we can use radiatively-driven ablation to generate high pressures in a wide variety of materials. PBFA-Z is being developed to generate centimeter scale hohlraums with temperatures from 80 to 150 eV. 1-D radiation/hydrodynamic simulations using these hohlraums predict the generation 1- to 15-Mbar pressures in a wide variety of materials through direct ablation. Through the use of thick ablators, we can obtain 4.5- to 25-Mbar pressures in Aluminum. This pressure regime can be extended to 40 Mbar for 200-eV hohlraums predicted for the X1, next generation, Z-pinch driver.

  5. Spiral waves in driven dusty plasma medium: Generalized hydrodynamic fluid description

    NASA Astrophysics Data System (ADS)

    Kumar, Sandeep; Patel, Bhavesh; Das, Amita

    2018-04-01

    Spiral waves are observed in many natural phenomena. They have been extensively represented by the mathematical FitzHugh-Nagumo model [Barkley et al., Phys. Rev. A 42, 2489 (1990)] of excitable media. Also, in incompressible fluid simulations, the excitation of thermal spiral waves has been reported by Li et al. [Phys. of Fluids 22, 011701 (2010)]. In the present paper, the spatiotemporal development of spiral waves in the context of weak and strong coupling limits has been shown. While the weakly coupled medium has been represented by a simple fluid description, for strong coupling, a generalized visco-elastic fluid description has been employed. The medium has been driven by an external force in the form of a rotating electric field. It is shown that when the amplitude of force is small, the density perturbations in the medium are also small. In this case, the excitations do not develop as a spiral wave. Only when the amplitude of force is high so as to drive the density perturbations to nonlinear amplitudes does the spiral density wave formation occurs. The role of the forcing frequency and the effect of strong coupling and the sound velocity of medium in the formation and evolution of spiral waves have been investigated in detail.

  6. Data-driven RANS for simulations of large wind farms

    NASA Astrophysics Data System (ADS)

    Iungo, G. V.; Viola, F.; Ciri, U.; Rotea, M. A.; Leonardi, S.

    2015-06-01

    In the wind energy industry there is a growing need for real-time predictions of wind turbine wake flows in order to optimize power plant control and inhibit detrimental wake interactions. To this aim, a data-driven RANS approach is proposed in order to achieve very low computational costs and adequate accuracy through the data assimilation procedure. The RANS simulations are implemented with a classical Boussinesq hypothesis and a mixing length turbulence closure model, which is calibrated through the available data. High-fidelity LES simulations of a utility-scale wind turbine operating with different tip speed ratios are used as database. It is shown that the mixing length model for the RANS simulations can be calibrated accurately through the Reynolds stress of the axial and radial velocity components, and the gradient of the axial velocity in the radial direction. It is found that the mixing length is roughly invariant in the very near wake, then it increases linearly with the downstream distance in the diffusive region. The variation rate of the mixing length in the downstream direction is proposed as a criterion to detect the transition between near wake and transition region of a wind turbine wake. Finally, RANS simulations were performed with the calibrated mixing length model, and a good agreement with the LES simulations is observed.

  7. Comparing Shock geometry from MHD simulation to that from the Q/A-scaling analysis

    NASA Astrophysics Data System (ADS)

    Li, G.; Zhao, L.; Jin, M.

    2017-12-01

    In large SEP events, ions can be accelerated at CME-driven shocks to very high energies. Spectra of heavy ions in many large SEP events show features such as roll-overs or spectral breaks. In some events when the spectra are plotted in energy/nucleon they can be shifted relatively to each other so that the spectra align. The amount of shift is charge-to-mass ratio (Q/A) dependent and varies from event to event. In the work of Li et al. (2009), the Q/A dependences of the scaling is related to shock geometry when the CME-driven shock is close to the Sun. For events where multiple in-situ spacecraft observations exist, one may expect that different spacecraft are connected to different portions of the CME-driven shock that have different shock geometries, therefore yielding different Q/A dependence. At the same time, shock geometry can be also obtained from MHD simulations. This means we can compare shock geometry from two completely different approaches: one from MHD simulation and the other from in-situ spectral fitting. In this work, we examine this comparison for selected events.

  8. Database-driven web interface automating gyrokinetic simulations for validation

    NASA Astrophysics Data System (ADS)

    Ernst, D. R.

    2010-11-01

    We are developing a web interface to connect plasma microturbulence simulation codes with experimental data. The website automates the preparation of gyrokinetic simulations utilizing plasma profile and magnetic equilibrium data from TRANSP analysis of experiments, read from MDSPLUS over the internet. This database-driven tool saves user sessions, allowing searches of previous simulations, which can be restored to repeat the same analysis for a new discharge. The website includes a multi-tab, multi-frame, publication quality java plotter Webgraph, developed as part of this project. Input files can be uploaded as templates and edited with context-sensitive help. The website creates inputs for GS2 and GYRO using a well-tested and verified back-end, in use for several years for the GS2 code [D. R. Ernst et al., Phys. Plasmas 11(5) 2637 (2004)]. A centralized web site has the advantage that users receive bug fixes instantaneously, while avoiding the duplicated effort of local compilations. Possible extensions to the database to manage run outputs, toward prototyping for the Fusion Simulation Project, are envisioned. Much of the web development utilized support from the DoE National Undergraduate Fellowship program [e.g., A. Suarez and D. R. Ernst, http://meetings.aps.org/link/BAPS.2005.DPP.GP1.57.

  9. Simulations and Characteristics of Large Solar Events Propagating Throughout the Heliosphere and Beyond (Invited)

    NASA Astrophysics Data System (ADS)

    Intriligator, D. S.; Sun, W.; Detman, T. R.; Dryer, Ph D., M.; Intriligator, J.; Deehr, C. S.; Webber, W. R.; Gloeckler, G.; Miller, W. D.

    2015-12-01

    Large solar events can have severe adverse global impacts at Earth. These solar events also can propagate throughout the heliopshere and into the interstellar medium. We focus on the July 2012 and Halloween 2003 solar events. We simulate these events starting from the vicinity of the Sun at 2.5 Rs. We compare our three dimensional (3D) time-dependent simulations to available spacecraft (s/c) observations at 1 AU and beyond. Based on the comparisons of the predictions from our simulations with in-situ measurements we find that the effects of these large solar events can be observed in the outer heliosphere, the heliosheath, and even into the interstellar medium. We use two simulation models. The HAFSS (HAF Source Surface) model is a kinematic model. HHMS-PI (Hybrid Heliospheric Modeling System with Pickup protons) is a numerical magnetohydrodynamic solar wind (SW) simulation model. Both HHMS-PI and HAFSS are ideally suited for these analyses since starting at 2.5 Rs from the Sun they model the slowly evolving background SW and the impulsive, time-dependent events associated with solar activity. Our models naturally reproduce dynamic 3D spatially asymmetric effects observed throughout the heliosphere. Pre-existing SW background conditions have a strong influence on the propagation of shock waves from solar events. Time-dependence is a crucial aspect of interpreting s/c data. We show comparisons of our simulation results with STEREO A, ACE, Ulysses, and Voyager s/c observations.

  10. DISCRETE EVENT SIMULATION OF OPTICAL SWITCH MATRIX PERFORMANCE IN COMPUTER NETWORKS

    DOE Office of Scientific and Technical Information (OSTI.GOV)

    Imam, Neena; Poole, Stephen W

    2013-01-01

    In this paper, we present application of a Discrete Event Simulator (DES) for performance modeling of optical switching devices in computer networks. Network simulators are valuable tools in situations where one cannot investigate the system directly. This situation may arise if the system under study does not exist yet or the cost of studying the system directly is prohibitive. Most available network simulators are based on the paradigm of discrete-event-based simulation. As computer networks become increasingly larger and more complex, sophisticated DES tool chains have become available for both commercial and academic research. Some well-known simulators are NS2, NS3, OPNET,more » and OMNEST. For this research, we have applied OMNEST for the purpose of simulating multi-wavelength performance of optical switch matrices in computer interconnection networks. Our results suggest that the application of DES to computer interconnection networks provides valuable insight in device performance and aids in topology and system optimization.« less

  11. Data Albums: An Event Driven Search, Aggregation and Curation Tool for Earth Science

    NASA Technical Reports Server (NTRS)

    Ramachandran, Rahul; Kulkarni, Ajinkya; Maskey, Manil; Bakare, Rohan; Basyal, Sabin; Li, Xiang; Flynn, Shannon

    2014-01-01

    Approaches used in Earth science research such as case study analysis and climatology studies involve discovering and gathering diverse data sets and information to support the research goals. To gather relevant data and information for case studies and climatology analysis is both tedious and time consuming. Current Earth science data systems are designed with the assumption that researchers access data primarily by instrument or geophysical parameter. In cases where researchers are interested in studying a significant event, they have to manually assemble a variety of datasets relevant to it by searching the different distributed data systems. This paper presents a specialized search, aggregation and curation tool for Earth science to address these challenges. The search rool automatically creates curated 'Data Albums', aggregated collections of information related to a specific event, containing links to relevant data files [granules] from different instruments, tools and services for visualization and analysis, and information about the event contained in news reports, images or videos to supplement research analysis. Curation in the tool is driven via an ontology based relevancy ranking algorithm to filter out non relevant information and data.

  12. General Relativistic Effects on Neutrino-driven Winds from Young, Hot Neutron Stars and r-Process Nucleosynthesis

    NASA Astrophysics Data System (ADS)

    Otsuki, Kaori; Tagoshi, Hideyuki; Kajino, Toshitaka; Wanajo, Shin-ya

    2000-04-01

    Neutrino-driven winds from young hot neutron stars, which are formed by supernova explosions, are the most promising candidate site for r-process nucleosynthesis. We study general relativistic effects on this wind in Schwarzschild geometry in order to look for suitable conditions for successful r-process nucleosynthesis. It is quantitatively demonstrated that general relativistic effects play a significant role in increasing the entropy and decreasing the dynamic timescale of the neutrino-driven wind. Exploring the wide parameter region that determines the expansion dynamics of the wind, we find interesting physical conditions that lead to successful r-process nucleosynthesis. The conditions that we found are realized in a neutrino-driven wind with a very short dynamic timescale, τdyn~6 ms, and a relatively low entropy, S~140. We carry out α-process and r-process nucleosynthesis calculations on these conditions with our single network code, which includes over 3000 isotopes, and confirm quantitatively that the second and third r-process abundance peaks are produced in neutrino-driven winds.

  13. 3D Simulation of External Flooding Events for the RISMC Pathway

    DOE Office of Scientific and Technical Information (OSTI.GOV)

    Prescott, Steven; Mandelli, Diego; Sampath, Ramprasad

    2015-09-01

    Incorporating 3D simulations as part of the Risk-Informed Safety Margins Characterization (RISMIC) Toolkit allows analysts to obtain a more complete picture of complex system behavior for events including external plant hazards. External events such as flooding have become more important recently – however these can be analyzed with existing and validated simulated physics toolkits. In this report, we describe these approaches specific to flooding-based analysis using an approach called Smoothed Particle Hydrodynamics. The theory, validation, and example applications of the 3D flooding simulation are described. Integrating these 3D simulation methods into computational risk analysis provides a spatial/visual aspect to themore » design, improves the realism of results, and can prove visual understanding to validate the analysis of flooding.« less

  14. Simulation of General Physics laboratory exercise

    NASA Astrophysics Data System (ADS)

    Aceituno, P.; Hernández-Aceituno, J.; Hernández-Cabrera, A.

    2015-01-01

    Laboratory exercises are an important part of general Physics teaching, both during the last years of high school and the first year of college education. Due to the need to acquire enough laboratory equipment for all the students, and the widespread access to computers rooms in teaching, we propose the development of computer simulated laboratory exercises. A representative exercise in general Physics is the calculation of the gravity acceleration value, through the free fall motion of a metal ball. Using a model of the real exercise, we have developed an interactive system which allows students to alter the starting height of the ball to obtain different fall times. The simulation was programmed in ActionScript 3, so that it can be freely executed in any operative system; to ensure the accuracy of the calculations, all the input parameters of the simulations were modelled using digital measurement units, and to allow a statistical management of the resulting data, measurement errors are simulated through limited randomization.

  15. A Multi-mission Event-Driven Component-Based System for Support of Flight Software Development, ATLO, and Operations first used by the Mars Science Laboratory (MSL) Project

    NASA Technical Reports Server (NTRS)

    Dehghani, Navid; Tankenson, Michael

    2006-01-01

    This paper details an architectural description of the Mission Data Processing and Control System (MPCS), an event-driven, multi-mission ground data processing components providing uplink, downlink, and data management capabilities which will support the Mars Science Laboratory (MSL) project as its first target mission. MPCS is developed based on a set of small reusable components, implemented in Java, each designed with a specific function and well-defined interfaces. An industry standard messaging bus is used to transfer information among system components. Components generate standard messages which are used to capture system information, as well as triggers to support the event-driven architecture of the system. Event-driven systems are highly desirable for processing high-rate telemetry (science and engineering) data, and for supporting automation for many mission operations processes.

  16. Rare measurements of a sprite with halo event driven by a negative lightning discharge over Argentina

    USGS Publications Warehouse

    Taylor, M.J.; Bailey, M.A.; Pautet, P.D.; Cummer, S.A.; Jaugey, N.; Thomas, J.N.; Solorzano, N.N.; Sao, Sabbas F.; Holzworth, R.H.; Pinto, O.; Schuch, N.J.

    2008-01-01

    As part of a collaborative campaign to investigate Transient Lummous Events (TLEs) over South America, coordinated optical, ELF/VLF, and lightning measurements were made of a mesoscale thunderstorm observed on February 22-23, 2006 over northern Argentina that produced 445 TLEs within a ???6 hour period. Here, we report comprehensive measurements of one of these events, a sprite with halo that was unambiguously associated with a large negative cloud-to-ground (CG) lightning discharge with an impulsive vertical charge moment change (??MQv) of -503 C.km. This event was similar in its location, morphology and duration to other positive TLEs observed from this storm. However, the downward extent of the negative streamers was limited to 25 km, and their apparent brightness was lower than that of a comparable positive event. Observations of negative CG events are rare, and these measurements provide fin-ther evidence that sprites can be driven by upward as well as downward electric fields, as predicted by the conventional breakdown mechanism. Copyright 2008 by the American Geophysical Union.

  17. Driven and decaying turbulence simulations of low–mass star formation: From clumps to cores to protostars

    DOE PAGES

    Offner, Stella S. R.; Klein, Richard I.; McKee, Christopher F.

    2008-10-20

    Molecular clouds are observed to be turbulent, but the origin of this turbulence is not well understood. As a result, there are two different approaches to simulating molecular clouds, one in which the turbulence is allowed to decay after it is initialized, and one in which it is driven. We use the adaptive mesh refinement (AMR) code, Orion, to perform high-resolution simulations of molecular cloud cores and protostars in environments with both driven and decaying turbulence. We include self-gravity, use a barotropic equation of state, and represent regions exceeding the maximum grid resolution with sink particles. We analyze the propertiesmore » of bound cores such as size, shape, line width, and rotational energy, and we find reasonable agreement with observation. At high resolution the different rates of core accretion in the two cases have a significant effect on protostellar system development. Clumps forming in a decaying turbulence environment produce high-multiplicity protostellar systems with Toomre Q unstable disks that exhibit characteristics of the competitive accretion model for star formation. In contrast, cores forming in the context of continuously driven turbulence and virial equilibrium form smaller protostellar systems with fewer low-mass members. Furthermore, our simulations of driven and decaying turbulence show some statistically significant differences, particularly in the production of brown dwarfs and core rotation, but the uncertainties are large enough that we are not able to conclude whether observations favor one or the other.« less

  18. Extreme events and event size fluctuations in biased random walks on networks.

    PubMed

    Kishore, Vimal; Santhanam, M S; Amritkar, R E

    2012-05-01

    Random walk on discrete lattice models is important to understand various types of transport processes. The extreme events, defined as exceedences of the flux of walkers above a prescribed threshold, have been studied recently in the context of complex networks. This was motivated by the occurrence of rare events such as traffic jams, floods, and power blackouts which take place on networks. In this work, we study extreme events in a generalized random walk model in which the walk is preferentially biased by the network topology. The walkers preferentially choose to hop toward the hubs or small degree nodes. In this setting, we show that extremely large fluctuations in event sizes are possible on small degree nodes when the walkers are biased toward the hubs. In particular, we obtain the distribution of event sizes on the network. Further, the probability for the occurrence of extreme events on any node in the network depends on its "generalized strength," a measure of the ability of a node to attract walkers. The generalized strength is a function of the degree of the node and that of its nearest neighbors. We obtain analytical and simulation results for the probability of occurrence of extreme events on the nodes of a network using a generalized random walk model. The result reveals that the nodes with a larger value of generalized strength, on average, display lower probability for the occurrence of extreme events compared to the nodes with lower values of generalized strength.

  19. Nonlinear simulations of beam-driven Compressional Alfv´en Eigenmodes in NSTX

    DOE PAGES

    Belova, Elena V.; Gorelenkov, N. N.; Crocker, N. A.; ...

    2017-03-10

    We present results for the 3D nonlinear simulations of neutral-beam-driven compressional Alfv´en eigenmodes (CAEs) in the National Spherical Torus Experiment (NSTX). Hybrid MHD-particle simulations for the H-mode NSTX discharge (shot 141398) using the HYM code show unstable CAE modes for a range of toroidal mode numbers, n = 4 - 9, and frequencies below the ion cyclotron frequency. It is found that the essential feature of CAEs is their coupling to kinetic Alfv´en wave (KAW) that occurs on the high-field side at the Alfv´en resonance location. We frequently observe high-frequency Alfv´en eigenmodes in beam-heated NSTX plasmas, and have been linkedmore » to flattening of the electron temperature profiles at high beam power. Coupling between CAE and KAW suggests an energy channeling mechanism to explain these observations, in which beam driven CAEs dissipate their energy at the resonance location, therefore significantly modifying the energy deposition profile. Nonlinear simulations demonstrate that CAEs can channel the energy of the beam ions from the injection region near the magnetic axis to the location of the resonant mode conversion at the edge of the beam density profile. Furthermore, a set of nonlinear simulations show that the CAE instability saturates due to nonlinear particle trapping, and a large fraction of beam energy can be transferred to several unstable CAEs of relatively large amplitudes and absorbed at the resonant location. Absorption rate shows a strong scaling with the beam power.« less

  20. Nonlinear simulations of beam-driven Compressional Alfv´en Eigenmodes in NSTX

    DOE Office of Scientific and Technical Information (OSTI.GOV)

    Belova, Elena V.; Gorelenkov, N. N.; Crocker, N. A.

    We present results for the 3D nonlinear simulations of neutral-beam-driven compressional Alfv´en eigenmodes (CAEs) in the National Spherical Torus Experiment (NSTX). Hybrid MHD-particle simulations for the H-mode NSTX discharge (shot 141398) using the HYM code show unstable CAE modes for a range of toroidal mode numbers, n = 4 - 9, and frequencies below the ion cyclotron frequency. It is found that the essential feature of CAEs is their coupling to kinetic Alfv´en wave (KAW) that occurs on the high-field side at the Alfv´en resonance location. We frequently observe high-frequency Alfv´en eigenmodes in beam-heated NSTX plasmas, and have been linkedmore » to flattening of the electron temperature profiles at high beam power. Coupling between CAE and KAW suggests an energy channeling mechanism to explain these observations, in which beam driven CAEs dissipate their energy at the resonance location, therefore significantly modifying the energy deposition profile. Nonlinear simulations demonstrate that CAEs can channel the energy of the beam ions from the injection region near the magnetic axis to the location of the resonant mode conversion at the edge of the beam density profile. Furthermore, a set of nonlinear simulations show that the CAE instability saturates due to nonlinear particle trapping, and a large fraction of beam energy can be transferred to several unstable CAEs of relatively large amplitudes and absorbed at the resonant location. Absorption rate shows a strong scaling with the beam power.« less

  1. Cardiovascular Events During General Elections In Bayamon, Puerto Rico

    PubMed Central

    Pérez-Mercado, Arnaldo E.; Maldonado-Martínez, Gerónimo; del Rio, José Rivera; Mellado, Robert F. Hunter

    2013-01-01

    Emotional stress has been linked to acute coronary events. We examined whether the emotional response to elections in Puerto Rico induced a similar response. Methods We reviewed records at HIMA San Pablo Hospital (HIMASP) and Ramon Ruiz Arnau University Hospital (HURRA) in Bayamón and identified patients admitted with ICD-9 codes 410, 411, and 413 or corresponding diagnoses during a period surrounding the general elections and compared them with the same time period in non-election years. Results Cardiovascular events accounted for 3.24% of election-year admissions vs. 5.51% during non-election years in HURRA (p=0.036, N=37), while accounting for 2.86% of election-year admissions in HIMASP vs. 3.27% during non-election years (non-significant). Discussion There was a trend towards a lower rate of admission for cardiovascular events during general elections in both hospitals, reaching statistical significance at HURRA. Further study may elucidate reasons for this behavior and determine whether similar trends hold true in other populations. PMID:23875518

  2. Assessing traumatic event exposure: general issues and preliminary findings for the Stressful Life Events Screening Questionnaire.

    PubMed

    Goodman, L A; Corcoran, C; Turner, K; Yuan, N; Green, B L

    1998-07-01

    This article reviews the psychometric properties of the Stressful Life Events Screening Questionnaire (SLESQ), a recently developed trauma history screening measure, and discusses the complexities involved in assessing trauma exposure. There are relatively few general measures of exposure to a variety of types of traumatic events, and most of those that exist have not been subjected to rigorous psychometric evaluation. The SLESQ showed good test-retest reliability, with a median kappa of .73, adequate convergent validity (with a lengthier interview) with a median kappa of .64, and good discrimination between Criterion A and non-Criterion A events. The discussion addresses some of the challenges of assessing traumatic event exposure along the dimensions of defining traumatic events, assessment methodologies, reporting consistency, and incident validation.

  3. SPEEDES - A multiple-synchronization environment for parallel discrete-event simulation

    NASA Technical Reports Server (NTRS)

    Steinman, Jeff S.

    1992-01-01

    Synchronous Parallel Environment for Emulation and Discrete-Event Simulation (SPEEDES) is a unified parallel simulation environment. It supports multiple-synchronization protocols without requiring users to recompile their code. When a SPEEDES simulation runs on one node, all the extra parallel overhead is removed automatically at run time. When the same executable runs in parallel, the user preselects the synchronization algorithm from a list of options. SPEEDES currently runs on UNIX networks and on the California Institute of Technology/Jet Propulsion Laboratory Mark III Hypercube. SPEEDES also supports interactive simulations. Featured in the SPEEDES environment is a new parallel synchronization approach called Breathing Time Buckets. This algorithm uses some of the conservative techniques found in Time Bucket synchronization, along with the optimism that characterizes the Time Warp approach. A mathematical model derived from first principles predicts the performance of Breathing Time Buckets. Along with the Breathing Time Buckets algorithm, this paper discusses the rules for processing events in SPEEDES, describes the implementation of various other synchronization protocols supported by SPEEDES, describes some new ones for the future, discusses interactive simulations, and then gives some performance results.

  4. A simulative comparison of respondent driven sampling with incentivized snowball sampling--the "strudel effect".

    PubMed

    Gyarmathy, V Anna; Johnston, Lisa G; Caplinskiene, Irma; Caplinskas, Saulius; Latkin, Carl A

    2014-02-01

    Respondent driven sampling (RDS) and incentivized snowball sampling (ISS) are two sampling methods that are commonly used to reach people who inject drugs (PWID). We generated a set of simulated RDS samples on an actual sociometric ISS sample of PWID in Vilnius, Lithuania ("original sample") to assess if the simulated RDS estimates were statistically significantly different from the original ISS sample prevalences for HIV (9.8%), Hepatitis A (43.6%), Hepatitis B (Anti-HBc 43.9% and HBsAg 3.4%), Hepatitis C (87.5%), syphilis (6.8%) and Chlamydia (8.8%) infections and for selected behavioral risk characteristics. The original sample consisted of a large component of 249 people (83% of the sample) and 13 smaller components with 1-12 individuals. Generally, as long as all seeds were recruited from the large component of the original sample, the simulation samples simply recreated the large component. There were no significant differences between the large component and the entire original sample for the characteristics of interest. Altogether 99.2% of 360 simulation sample point estimates were within the confidence interval of the original prevalence values for the characteristics of interest. When population characteristics are reflected in large network components that dominate the population, RDS and ISS may produce samples that have statistically non-different prevalence values, even though some isolated network components may be under-sampled and/or statistically significantly different from the main groups. This so-called "strudel effect" is discussed in the paper. Copyright © 2013 Elsevier Ireland Ltd. All rights reserved.

  5. Massively parallel algorithms for trace-driven cache simulations

    NASA Technical Reports Server (NTRS)

    Nicol, David M.; Greenberg, Albert G.; Lubachevsky, Boris D.

    1991-01-01

    Trace driven cache simulation is central to computer design. A trace is a very long sequence of reference lines from main memory. At the t(exp th) instant, reference x sub t is hashed into a set of cache locations, the contents of which are then compared with x sub t. If at the t sup th instant x sub t is not present in the cache, then it is said to be a miss, and is loaded into the cache set, possibly forcing the replacement of some other memory line, and making x sub t present for the (t+1) sup st instant. The problem of parallel simulation of a subtrace of N references directed to a C line cache set is considered, with the aim of determining which references are misses and related statistics. A simulation method is presented for the Least Recently Used (LRU) policy, which regradless of the set size C runs in time O(log N) using N processors on the exclusive read, exclusive write (EREW) parallel model. A simpler LRU simulation algorithm is given that runs in O(C log N) time using N/log N processors. Timings are presented of the second algorithm's implementation on the MasPar MP-1, a machine with 16384 processors. A broad class of reference based line replacement policies are considered, which includes LRU as well as the Least Frequently Used and Random replacement policies. A simulation method is presented for any such policy that on any trace of length N directed to a C line set runs in the O(C log N) time with high probability using N processors on the EREW model. The algorithms are simple, have very little space overhead, and are well suited for SIMD implementation.

  6. Numerical simulations of continuum-driven winds of super-Eddington stars

    NASA Astrophysics Data System (ADS)

    van Marle, A. J.; Owocki, S. P.; Shaviv, N. J.

    2008-09-01

    We present the results of numerical simulations of continuum-driven winds of stars that exceed the Eddington limit and compare these against predictions from earlier analytical solutions. Our models are based on the assumption that the stellar atmosphere consists of clumped matter, where the individual clumps have a much larger optical thickness than the matter between the clumps. This `porosity' of the stellar atmosphere reduces the coupling between radiation and matter, since photons tend to escape through the more tenuous gas between the clumps. This allows a star that formally exceeds the Eddington limit to remain stable, yet produce a steady outflow from the region where the clumps become optically thin. We have made a parameter study of wind models for a variety of input conditions in order to explore the properties of continuum-driven winds. The results show that the numerical simulations reproduce quite closely the analytical scalings. The mass-loss rates produced in our models are much larger than can be achieved by line driving. This makes continuum driving a good mechanism to explain the large mass-loss and flow speeds of giant outbursts, as observed in η Carinae and other luminous blue variable stars. Continuum driving may also be important in population III stars, since line driving becomes ineffective at low metallicities. We also explore the effect of photon tiring and the limits it places on the wind parameters.

  7. Relation of Parallel Discrete Event Simulation algorithms with physical models

    NASA Astrophysics Data System (ADS)

    Shchur, L. N.; Shchur, L. V.

    2015-09-01

    We extend concept of local simulation times in parallel discrete event simulation (PDES) in order to take into account architecture of the current hardware and software in high-performance computing. We shortly review previous research on the mapping of PDES on physical problems, and emphasise how physical results may help to predict parallel algorithms behaviour.

  8. Modeling a Million-Node Slim Fly Network Using Parallel Discrete-Event Simulation

    DOE Office of Scientific and Technical Information (OSTI.GOV)

    Wolfe, Noah; Carothers, Christopher; Mubarak, Misbah

    As supercomputers close in on exascale performance, the increased number of processors and processing power translates to an increased demand on the underlying network interconnect. The Slim Fly network topology, a new lowdiameter and low-latency interconnection network, is gaining interest as one possible solution for next-generation supercomputing interconnect systems. In this paper, we present a high-fidelity Slim Fly it-level model leveraging the Rensselaer Optimistic Simulation System (ROSS) and Co-Design of Exascale Storage (CODES) frameworks. We validate our Slim Fly model with the Kathareios et al. Slim Fly model results provided at moderately sized network scales. We further scale the modelmore » size up to n unprecedented 1 million compute nodes; and through visualization of network simulation metrics such as link bandwidth, packet latency, and port occupancy, we get an insight into the network behavior at the million-node scale. We also show linear strong scaling of the Slim Fly model on an Intel cluster achieving a peak event rate of 36 million events per second using 128 MPI tasks to process 7 billion events. Detailed analysis of the underlying discrete-event simulation performance shows that a million-node Slim Fly model simulation can execute in 198 seconds on the Intel cluster.« less

  9. Spectral element simulation of precession driven flows in the outer cores of spheroidal planets

    NASA Astrophysics Data System (ADS)

    Vormann, Jan; Hansen, Ulrich

    2015-04-01

    A common feature of the planets in the solar system is the precession of the rotation axes, driven by the gravitational influence of another body (e.g. the Earth's moon). In a precessing body, the rotation axis itself is rotating around another axis, describing a cone during one precession period. Similar to the coriolis and centrifugal force appearing from the transformation to a rotating system, the addition of precession adds another term to the Navier-Stokes equation, the so called Poincaré force. The main geophysical motivation in studying precession driven flows comes from their ability to act as magnetohydrodynamic dynamos in planets and moons. Precession may either act as the only driving force or operate together with other forces such as thermochemical convection. One of the challenges in direct numerical simulations of such flows lies in the spheroidal shape of the fluid volume, which should not be neglected since it contributes an additional forcing trough pressure torques. Codes developed for the simulation of flows in spheres mostly use efficient global spectral algorithms that converge fast, but lack geometric flexibility, while local methods are usable in more complex shapes, but often lack high accuracy. We therefore adapted the spectral element code Nek5000, developed at Argonne National Laboratory, to the problem. The spectral element method is capable of solving for the flow in arbitrary geometries while still offering spectral convergence. We present first results for the simulation of a purely hydrodynamic, precession-driven flow in a spheroid with no-slip boundaries and an inner core. The driving by the Poincaré force is in a range where theoretical work predicts multiple solutions for a laminar flow. Our simulations indicate a transition to turbulent flows for Ekman numbers of 10-6 and lower.

  10. Discrete Element Simulations of Density-Driven Volcanic Deformation: Applications to Martian and Terrestrial Volcanoes

    NASA Astrophysics Data System (ADS)

    Farrell, L. L.; McGovern, P. J.; Morgan, J. K.

    2008-12-01

    We have carried out 2-D numerical simulations using the discrete element method (DEM) to investigate density-driven deformation in volcanic edifices on Earth (e.g., Hawaii) and Mars (e.g., Olympus Mons and Arsia Mons). Located within volcanoes are series of magma chambers, reservoirs, and conduits where magma travels and collects. As magma differentiates, dense minerals settle out, building thick accumulations referred to as cumulates that can flow ductilely due to stresses imparted by gravity. To simulate this process, we construct granular piles subject to Coulomb frictional rheology, incrementally capture internal rectangular regions to which higher densities and lower interparticle friction values are assigned (analogs for denser, weaker cumulates), and then bond the granular edifice. Thus, following each growth increment, the edifice is allowed to relax gravitationally with a reconfigured weak cumulate core. The presence and outward spreading of the cumulate causes the development of distinctive structural and stratigraphic patterns. We obtained a range of volcanic shapes that vary from broad, shallowly dipping flanks reminiscent of those of Olympus Mons, to short, steep surface slopes more similar to Arsia Mons. Edifices lacking internal cumulate exhibit relatively horizontal strata compared to the high-angle, inward dipping strata that develops within the cumulate-bearing edifices. Our simulated volcanoes also illustrate a variety of gravity driven deformation features, including regions of thrust faulting within the flanks and large-scale flank collapses, as observed in Hawaii and inferred on Olympus Mons. We also see significant summit subsidence, and of particular interest, distinct summit calderas. The broad, flat caldera and convex upward profile of Arsia Mons appears to be well-simulated by cumulate-driven volcanic spreading. In contrast, the concave upward slopes of Olympus Mons are more challenging to reproduce, and instead are attributed to volcanic

  11. GENERAL: A Possible Population-Driven Phase Transition in Cicada Chorus

    NASA Astrophysics Data System (ADS)

    Gu, Si-Yuan; Jin, Yu-Liang; Zhao, Xiao-Xue; Huang, Ji-Ping

    2009-06-01

    We investigate the collective synchronization of cicada chirping. Using both experimental and phenomenological numerical techniques, here we show that the onset of a periodic two-state acoustic synchronous behavior in cicada chorus depends on a critical size of population Nc = 21, above which a typical chorus state appears periodically with a 30 second-silence state in between, and further clarify its possibility concerning a new class of phase transition, which is unusually driven by population. This work has relevance to acoustic synchronization and to general physics of phase transition.

  12. Global MHD simulations driven by idealized Alfvenic fluctuations in the solar wind

    NASA Astrophysics Data System (ADS)

    Claudepierre, S. G.

    2017-12-01

    High speed solar wind streams (HSSs) and corotating interaction regions (CIRs) often lead to MeV electron flux enhancements the Earth's outer radiation belt. The relevant physical processes responsible for these enhancements are not entirely understood. We investigate the potential role that solar wind Alfvenic fluctuations, intrinsic structures embedded in the HSS/CIRs, play in radiation belt dynamics. In particular, we explore the hypothesis that magnetospheric ultra-low frequency (ULF) pulsations driven by interplanetary magnetic field fluctuations are the intermediary mechanism responsible for the pronounced effect that HSS/CIRs have on the outer electron radiation belt. We examine these effects using global, three-dimensional magnetohydrodynamic (MHD) simulations driven by idealized interplanetary Alfvenic fluctuations, both monochromatic and broadband noise (Kolmogorov turbulence).

  13. Response of the Antarctic Stratosphere to Warm Pool EI Nino Events in the GEOS CCM

    NASA Technical Reports Server (NTRS)

    Hurwitz, Margaret M.; Song, In-Sun; Oman, Luke D.; Newman, Paul A.; Molod, Andrea M.; Frith, Stacey M.; Nielsen, J. Eric

    2011-01-01

    A new type of EI Nino event has been identified in the last decade. During "warm pool" EI Nino (WPEN) events, sea surface temperatures (SSTs) in the central equatorial Pacific are warmer than average. The EI Nino signal propagates poleward and upward as large-scale atmospheric waves, causing unusual weather patterns and warming the polar stratosphere. In austral summer, observations show that the Antarctic lower stratosphere is several degrees (K) warmer during WPEN events than during the neutral phase of EI Nino/Southern Oscillation (ENSO). Furthermore, the stratospheric response to WPEN events depends of the direction of tropical stratospheric winds: the Antarctic warming is largest when WPEN events are coincident with westward winds in the tropical lower and middle stratosphere i.e., the westward phase of the quasi-biennial oscillation (QBO). Westward winds are associated with enhanced convection in the subtropics, and with increased poleward wave activity. In this paper, a new formulation of the Goddard Earth Observing System Chemistry-Climate Model, Version 2 (GEOS V2 CCM) is used to substantiate the observed stratospheric response to WPEN events. One simulation is driven by SSTs typical of a WPEN event, while another simulation is driven by ENSO neutral SSTs; both represent a present-day climate. Differences between the two simulations can be directly attributed to the anomalous WPEN SSTs. During WPEN events, relative to ENSO neutral, the model simulates the observed increase in poleward planetary wave activity in the South Pacific during austral spring, as well as the relative warming of the Antarctic lower stratosphere in austral summer. However, the modeled response to WPEN does not depend on the phase of the QBO. The modeled tropical wind oscillation does not extend far enough into the lower stratosphere and upper troposphere, likely explaining the model's insensitivity to the phase of the QBO during WPEN events.

  14. Multilevel Effects in a Driven Generalized Rabi Model

    NASA Astrophysics Data System (ADS)

    Pietikäinen, I.; Danilin, S.; Kumar, K. S.; Tuorila, J.; Paraoanu, G. S.

    2018-01-01

    We study numerically the onset of higher-level excitations and resonance frequency shifts in the generalized multilevel Rabi model with dispersive coupling under strong driving. The response to a weak probe is calculated using the Floquet method, which allows us to calculate the probe spectrum and extract the resonance frequency. We test our predictions using a superconducting circuit consisting of a transmon coupled capacitively to a coplanar waveguide resonator. This system is monitored by a weak probe field and at the same time driven at various powers by a stronger microwave tone. We show that the transition from the quantum to the classical regime is accompanied by a rapid increase of the transmon occupation and consequently that the qubit approximation is valid only in the extreme quantum limit.

  15. Multilevel Effects in a Driven Generalized Rabi Model

    NASA Astrophysics Data System (ADS)

    Pietikäinen, I.; Danilin, S.; Kumar, K. S.; Tuorila, J.; Paraoanu, G. S.

    2018-06-01

    We study numerically the onset of higher-level excitations and resonance frequency shifts in the generalized multilevel Rabi model with dispersive coupling under strong driving. The response to a weak probe is calculated using the Floquet method, which allows us to calculate the probe spectrum and extract the resonance frequency. We test our predictions using a superconducting circuit consisting of a transmon coupled capacitively to a coplanar waveguide resonator. This system is monitored by a weak probe field and at the same time driven at various powers by a stronger microwave tone. We show that the transition from the quantum to the classical regime is accompanied by a rapid increase of the transmon occupation and consequently that the qubit approximation is valid only in the extreme quantum limit.

  16. Simulating recurrent event data with hazard functions defined on a total time scale.

    PubMed

    Jahn-Eimermacher, Antje; Ingel, Katharina; Ozga, Ann-Kathrin; Preussler, Stella; Binder, Harald

    2015-03-08

    In medical studies with recurrent event data a total time scale perspective is often needed to adequately reflect disease mechanisms. This means that the hazard process is defined on the time since some starting point, e.g. the beginning of some disease, in contrast to a gap time scale where the hazard process restarts after each event. While techniques such as the Andersen-Gill model have been developed for analyzing data from a total time perspective, techniques for the simulation of such data, e.g. for sample size planning, have not been investigated so far. We have derived a simulation algorithm covering the Andersen-Gill model that can be used for sample size planning in clinical trials as well as the investigation of modeling techniques. Specifically, we allow for fixed and/or random covariates and an arbitrary hazard function defined on a total time scale. Furthermore we take into account that individuals may be temporarily insusceptible to a recurrent incidence of the event. The methods are based on conditional distributions of the inter-event times conditional on the total time of the preceeding event or study start. Closed form solutions are provided for common distributions. The derived methods have been implemented in a readily accessible R script. The proposed techniques are illustrated by planning the sample size for a clinical trial with complex recurrent event data. The required sample size is shown to be affected not only by censoring and intra-patient correlation, but also by the presence of risk-free intervals. This demonstrates the need for a simulation algorithm that particularly allows for complex study designs where no analytical sample size formulas might exist. The derived simulation algorithm is seen to be useful for the simulation of recurrent event data that follow an Andersen-Gill model. Next to the use of a total time scale, it allows for intra-patient correlation and risk-free intervals as are often observed in clinical trial data

  17. Generalization of the event-based Carnevale-Hines integration scheme for integrate-and-fire models.

    PubMed

    van Elburg, Ronald A J; van Ooyen, Arjen

    2009-07-01

    An event-based integration scheme for an integrate-and-fire neuron model with exponentially decaying excitatory synaptic currents and double exponential inhibitory synaptic currents has been introduced by Carnevale and Hines. However, the integration scheme imposes nonphysiological constraints on the time constants of the synaptic currents, which hamper its general applicability. This letter addresses this problem in two ways. First, we provide physical arguments demonstrating why these constraints on the time constants can be relaxed. Second, we give a formal proof showing which constraints can be abolished. As part of our formal proof, we introduce the generalized Carnevale-Hines lemma, a new tool for comparing double exponentials as they naturally occur in many cascaded decay systems, including receptor-neurotransmitter dissociation followed by channel closing. Through repeated application of the generalized lemma, we lift most of the original constraints on the time constants. Thus, we show that the Carnevale-Hines integration scheme for the integrate-and-fire model can be employed for simulating a much wider range of neuron and synapse types than was previously thought.

  18. A user-driven treadmill control scheme for simulating overground locomotion.

    PubMed

    Kim, Jonghyun; Stanley, Christopher J; Curatalo, Lindsey A; Park, Hyung-Soon

    2012-01-01

    Treadmill-based locomotor training should simulate overground walking as closely as possible for optimal skill transfer. The constant speed of a standard treadmill encourages automaticity rather than engagement and fails to simulate the variable speeds encountered during real-world walking. To address this limitation, this paper proposes a user-driven treadmill velocity control scheme that allows the user to experience natural fluctuations in walking velocity with minimal unwanted inertial force due to acceleration/deceleration of the treadmill belt. A smart estimation limiter in the scheme effectively attenuates the inertial force during velocity changes. The proposed scheme requires measurement of pelvic and swing foot motions, and is developed for a treadmill of typical belt length (1.5 m). The proposed scheme is quantitatively evaluated here with four healthy subjects by comparing it with the most advanced control scheme identified in the literature.

  19. Sensitivity of Water Scarcity Events to ENSO-Driven Climate Variability at the Global Scale

    NASA Technical Reports Server (NTRS)

    Veldkamp, T. I. E.; Eisner, S.; Wada, Y.; Aerts, J. C. J. H.; Ward, P. J.

    2015-01-01

    Globally, freshwater shortage is one of the most dangerous risks for society. Changing hydro-climatic and socioeconomic conditions have aggravated water scarcity over the past decades. A wide range of studies show that water scarcity will intensify in the future, as a result of both increased consumptive water use and, in some regions, climate change. Although it is well-known that El Niño- Southern Oscillation (ENSO) affects patterns of precipitation and drought at global and regional scales, little attention has yet been paid to the impacts of climate variability on water scarcity conditions, despite its importance for adaptation planning. Therefore, we present the first global-scale sensitivity assessment of water scarcity to ENSO, the most dominant signal of climate variability. We show that over the time period 1961-2010, both water availability and water scarcity conditions are significantly correlated with ENSO-driven climate variability over a large proportion of the global land area (> 28.1 %); an area inhabited by more than 31.4% of the global population. We also found, however, that climate variability alone is often not enough to trigger the actual incidence of water scarcity events. The sensitivity of a region to water scarcity events, expressed in terms of land area or population exposed, is determined by both hydro-climatic and socioeconomic conditions. Currently, the population actually impacted by water scarcity events consists of 39.6% (CTA: consumption-to-availability ratio) and 41.1% (WCI: water crowding index) of the global population, whilst only 11.4% (CTA) and 15.9% (WCI) of the global population is at the same time living in areas sensitive to ENSO-driven climate variability. These results are contrasted, however, by differences in growth rates found under changing socioeconomic conditions, which are relatively high in regions exposed to water scarcity events. Given the correlations found between ENSO and water availability and scarcity

  20. Microbial ice nucleators scavenged from the atmosphere during simulated rain events

    NASA Astrophysics Data System (ADS)

    Hanlon, Regina; Powers, Craig; Failor, Kevin; Monteil, Caroline L.; Vinatzer, Boris A.; Schmale, David G.

    2017-08-01

    Rain and snow collected at ground level have been found to contain biological ice nucleators. These ice nucleators have been proposed to have originated in clouds, where they may have participated in the formation of precipitation via ice phase nucleation. We conducted a series of field experiments to test the hypothesis that at least some of the microbial ice nucleators (prokaryotes and eukaryotes) present in rain may not originate in clouds but instead be scavenged from the lower atmosphere by rainfall. Thirty-three simulated rain events were conducted over four months off the side of the Smart Road Bridge in Blacksburg, VA, USA. In each event, sterile water was dispensed over the side of the bridge and recovered in sterile containers in an open fallow agricultural field below (a distance of ∼55 m). Microbes scavenged from the simulated rain events were cultured and their ice nucleation activity was examined. Putative microbial ice nucleators were cultured from 94% (31/33) of the simulated rain events, and represented 1.5% (121/8331) of the total colonies assayed. Putative ice nucleators were subjected to additional droplet freezing assays, and those confirmed through these repeated assays represented 0.4% (34/8331) of the total. Mean CFUs scavenged by simulated rain ranged from 2 to 267 CFUs/mL. Scavenged ice nucleators belong to a number of taxa including the bacterial genera Pseudomonas, Pantoea, and Xanthomonas, and the fungal genera Fusarium, Humicola, and Mortierella. An ice-nucleating strain of the fungal genus Penicillium was also recovered from a volumetric air sampler at the study site. This work expands our knowledge of the scavenging properties of rainfall, and suggests that at least some ice nucleators in natural precipitation events may have been scrubbed from the atmosphere during rainfall, and thus are not likely to be involved in precipitation.

  1. Men who have sex with men more often chose daily than event-driven use of pre-exposure prophylaxis: baseline analysis of a demonstration study in Amsterdam.

    PubMed

    Hoornenborg, Elske; Achterbergh, Roel Ca; van der Loeff, Maarten F Schim; Davidovich, Udi; van der Helm, Jannie J; Hogewoning, Arjan; van Duijnhoven, Yvonne Thp; Sonder, Gerard Jb; de Vries, Henry Jc; Prins, Maria

    2018-03-01

    The Amsterdam PrEP project is a prospective, open-label demonstration study at a large sexually transmitted infection (STI) clinic. We examined the uptake of PrEP; the baseline characteristics of men who have sex with men (MSM) and transgender persons initiating PrEP; their choices of daily versus event-driven PrEP and the determinants of these choices. From August 2015 through May 2016, enrolment took place at the STI clinic of the Public Health Service of Amsterdam, the Netherlands. MSM or transgender persons were eligible if they had at least one risk factor for HIV infection within the preceding six months. Participants were offered a choice between daily or event-driven use of tenofovir/emtricitabine. Baseline data were analysed using descriptive statistics and multivariable analysis was employed to determine variables associated with daily versus event-driven PrEP. Online applications were submitted by 870 persons, of whom 587 were invited for a screening visit. Of them, 415 were screened for eligibility and 376 initiated PrEP. One quarter (103/376, 27%) chose event-driven PrEP. Prevalence of bacterial STI was 19.0% and mean condomless anal sex (CAS) episodes in the preceding three months were 11. In multivariable analysis, older age (≥45 vs. ≤34, aOR 2.1, 95% CI 1.2 to 3.9), being involved in a steady relationship (aOR 1.7, 95% CI 1.0 to 2.7), no other daily medication use (aOR 0.6, 95% CI 0.3 to 0.9), and fewer episodes of CAS (per log increase aOR 0.7, 95% CI 0.6 to 0.9) were determinants for choosing event-driven PrEP. PrEP programmes are becoming one of the more important intervention strategies with the goal of reducing incident HIV-infection and we were unable to accommodate many of the persons applying for this study. Offering a choice of dosing regimen to PrEP users may enable further personalization of HIV prevention strategies and enhance up-take, adherence and cost-effectiveness. The majority of participants preferred daily versus event-driven

  2. Tidal Disruption Events from Eccentric Nuclear Disks

    NASA Astrophysics Data System (ADS)

    Wernke, Heather N.; Madigan, Ann-Marie

    2018-04-01

    Stars that get too close to a supermassive black hole are in danger of being tidally disrupted. Stellar two-body relaxation is commonly assumed to be the main driver of these events. Recent work has shown, however, that secular gravitational torques from eccentric nuclear disks can push stars to extreme eccentricities at much higher rates than predicted by two-body relaxation. This work did not include the effects of general relativity, however, which could quench secular torques via rapid apsidal precession. Here we show that, for a star in danger of disruption, general relativity acts on a timescale of less than an orbital period. This short timescale means that general relativity does not have enough time to have a major effect on the orbit. When driven by secular torques from eccentric nuclear disks, tidal disruption event rates are not affected by general relativity.

  3. Fluctuation-dissipation relations for motions of center of mass in driven granular fluids under gravity.

    PubMed

    Wakou, Jun'ichi; Isobe, Masaharu

    2012-06-01

    We investigated the validity of fluctuation-dissipation relations in the nonequilibrium stationary state of fluidized granular media under gravity by two independent approaches, based on theory and numerical simulations. A phenomenological Langevin-type theory describing the fluctuation of center of mass height, which was originally constructed for a one-dimensional granular gas on a vibrating bottom plate, was generalized to any dimensionality, even for the case in which the vibrating bottom plate is replaced by a thermal wall. The theory predicts a fluctuation-dissipation relation known to be satisfied at equilibrium, with a modification that replaces the equilibrium temperature by an effective temperature defined by the center of mass kinetic energy. To test the validity of the fluctuation-dissipation relation, we performed extensive and accurate event-driven molecular dynamics simulations for the model system with a thermal wall at the bottom. The power spectrum and response function of the center of mass height were measured and closely compared with theoretical predictions. It is shown that the fluctuation-dissipation relation for the granular system is satisfied, especially in the high-frequency (short time) region, for a wide range of system parameters. Finally, we describe the relationship between systematic deviations in the low-frequency (long time) region and the time scales of the driven granular system.

  4. A discrete event simulation tool to support and predict hospital and clinic staffing.

    PubMed

    DeRienzo, Christopher M; Shaw, Ryan J; Meanor, Phillip; Lada, Emily; Ferranti, Jeffrey; Tanaka, David

    2017-06-01

    We demonstrate how to develop a simulation tool to help healthcare managers and administrators predict and plan for staffing needs in a hospital neonatal intensive care unit using administrative data. We developed a discrete event simulation model of nursing staff needed in a neonatal intensive care unit and then validated the model against historical data. The process flow was translated into a discrete event simulation model. Results demonstrated that the model can be used to give a respectable estimate of annual admissions, transfers, and deaths based upon two different staffing levels. The discrete event simulation tool model can provide healthcare managers and administrators with (1) a valid method of modeling patient mix, patient acuity, staffing needs, and costs in the present state and (2) a forecast of how changes in a unit's staffing, referral patterns, or patient mix would affect a unit in a future state.

  5. Discrete event simulation of patient admissions to a neurovascular unit.

    PubMed

    Hahn-Goldberg, S; Chow, E; Appel, E; Ko, F T F; Tan, P; Gavin, M B; Ng, T; Abrams, H B; Casaubon, L K; Carter, M W

    2014-01-01

    Evidence exists that clinical outcomes improve for stroke patients admitted to specialized Stroke Units. The Toronto Western Hospital created a Neurovascular Unit (NVU) using beds from general internal medicine, Neurology and Neurosurgery to care for patients with stroke and acute neurovascular conditions. Using patient-level data for NVU-eligible patients, a discrete event simulation was created to study changes in patient flow and length of stay pre- and post-NVU implementation. Varying patient volumes and resources were tested to determine the ideal number of beds under various conditions. In the first year of operation, the NVU admitted 507 patients, over 66% of NVU-eligible patient volumes. With the introduction of the NVU, length of stay decreased by around 8%. Scenario testing showed that the current level of 20 beds is sufficient for accommodating the current demand and would continue to be sufficient with an increase in demand of up to 20%.

  6. Sensitivity of WRF-ARW for Heavy Precipitation Event over the Eastern Black Sea Region

    NASA Astrophysics Data System (ADS)

    Doǧan, Onur Hakan; Önol, Barış

    2017-04-01

    In this study, we examined the extreme summer precipitation case over the Eastern Black Sea region of Turkey by using WRF-ARW. 11 people were killed by the flood and many buildings were damaged by the landslides in Artvin province. The flood caused by heavy precipitation between August 23 and 24, 2015 and the station observation is 255 mm total precipitation for the two days. We have also used satellite based observational data (Global Precipitation Measurement: GPM), which represents 150 mm total precipitation during case, to validate precipitation simulations. We designed three nested domains with 27-9-3 km resolutions for the simulations and the inner domain covers the all Black Sea and the surrounded coasts. The simulations have been driven by ECMWF ERA-Interim data and the initial conditions have been generated for 4 different simulations which are 3-days, 7-days, 15-days and 25-days long. WRF-ARW model physics parameters have been tested to improve simulation capability for extreme precipitation events. The microphysics (Kessler and New-Thompson) and PBL (YSU PBL and Mellor-Yamada-Janjic) options have been applied for each simulations separately, therefore 15 sensitivity simulation have been analyzed by using different parametrizations. In general, all simulations underestimated the two days extreme precipitation event which the large scale flow interact with warmer sea surface temperatures and complex topography over the eastern Black Sea region. The 3-days simulation with Kessler microphysics and YSU PBL predicts 148 mm precipitation which is highest simulated precipitation compare to all simulations for the corresponding station location. Moreover 25-days simulation represents better spatial coverage for precipitation pattern compare to the GPM data.

  7. Discrete event simulation tool for analysis of qualitative models of continuous processing systems

    NASA Technical Reports Server (NTRS)

    Malin, Jane T. (Inventor); Basham, Bryan D. (Inventor); Harris, Richard A. (Inventor)

    1990-01-01

    An artificial intelligence design and qualitative modeling tool is disclosed for creating computer models and simulating continuous activities, functions, and/or behavior using developed discrete event techniques. Conveniently, the tool is organized in four modules: library design module, model construction module, simulation module, and experimentation and analysis. The library design module supports the building of library knowledge including component classes and elements pertinent to a particular domain of continuous activities, functions, and behavior being modeled. The continuous behavior is defined discretely with respect to invocation statements, effect statements, and time delays. The functionality of the components is defined in terms of variable cluster instances, independent processes, and modes, further defined in terms of mode transition processes and mode dependent processes. Model construction utilizes the hierarchy of libraries and connects them with appropriate relations. The simulation executes a specialized initialization routine and executes events in a manner that includes selective inherency of characteristics through a time and event schema until the event queue in the simulator is emptied. The experimentation and analysis module supports analysis through the generation of appropriate log files and graphics developments and includes the ability of log file comparisons.

  8. Force-velocity relation for actin-polymerization-driven motility from Brownian dynamics simulations.

    PubMed

    Lee, Kun-Chun; Liu, Andrea J

    2009-09-02

    We report numerical simulation results for the force-velocity relation for actin-polymerization-driven motility. We use Brownian dynamics to solve a physically consistent formulation of the dendritic nucleation model with semiflexible filaments that self-assemble and push a disk. We find that at small loads, the disk speed is independent of load, whereas at high loads, the speed decreases and vanishes at a characteristic stall pressure. Our results demonstrate that at small loads, the velocity is controlled by the reaction rates, whereas at high loads the stall pressure is determined by the mechanical properties of the branched actin network. The behavior is consistent with experiments and with our recently proposed self-diffusiophoretic mechanism for actin-polymerization-driven motility. New in vitro experiments to measure the force-velocity relation are proposed.

  9. Using Discrete Event Simulation for Programming Model Exploration at Extreme-Scale: Macroscale Components for the Structural Simulation Toolkit (SST).

    DOE Office of Scientific and Technical Information (OSTI.GOV)

    Wilke, Jeremiah J; Kenny, Joseph P.

    2015-02-01

    Discrete event simulation provides a powerful mechanism for designing and testing new extreme- scale programming models for high-performance computing. Rather than debug, run, and wait for results on an actual system, design can first iterate through a simulator. This is particularly useful when test beds cannot be used, i.e. to explore hardware or scales that do not yet exist or are inaccessible. Here we detail the macroscale components of the structural simulation toolkit (SST). Instead of depending on trace replay or state machines, the simulator is architected to execute real code on real software stacks. Our particular user-space threading frameworkmore » allows massive scales to be simulated even on small clusters. The link between the discrete event core and the threading framework allows interesting performance metrics like call graphs to be collected from a simulated run. Performance analysis via simulation can thus become an important phase in extreme-scale programming model and runtime system design via the SST macroscale components.« less

  10. Validation of a DICE Simulation Against a Discrete Event Simulation Implemented Entirely in Code.

    PubMed

    Möller, Jörgen; Davis, Sarah; Stevenson, Matt; Caro, J Jaime

    2017-10-01

    Modeling is an essential tool for health technology assessment, and various techniques for conceptualizing and implementing such models have been described. Recently, a new method has been proposed-the discretely integrated condition event or DICE simulation-that enables frequently employed approaches to be specified using a common, simple structure that can be entirely contained and executed within widely available spreadsheet software. To assess if a DICE simulation provides equivalent results to an existing discrete event simulation, a comparison was undertaken. A model of osteoporosis and its management programmed entirely in Visual Basic for Applications and made public by the National Institute for Health and Care Excellence (NICE) Decision Support Unit was downloaded and used to guide construction of its DICE version in Microsoft Excel ® . The DICE model was then run using the same inputs and settings, and the results were compared. The DICE version produced results that are nearly identical to the original ones, with differences that would not affect the decision direction of the incremental cost-effectiveness ratios (<1% discrepancy), despite the stochastic nature of the models. The main limitation of the simple DICE version is its slow execution speed. DICE simulation did not alter the results and, thus, should provide a valid way to design and implement decision-analytic models without requiring specialized software or custom programming. Additional efforts need to be made to speed up execution.

  11. Measuring implosion velocities in experiments and simulations of laser-driven cylindrical implosions on the OMEGA laser

    NASA Astrophysics Data System (ADS)

    Hansen, E. C.; Barnak, D. H.; Betti, R.; Campbell, E. M.; Chang, P.-Y.; Davies, J. R.; Glebov, V. Yu; Knauer, J. P.; Peebles, J.; Regan, S. P.; Sefkow, A. B.

    2018-05-01

    Laser-driven magnetized liner inertial fusion (MagLIF) on OMEGA involves cylindrical implosions, a preheat beam, and an applied magnetic field. Initial experiments excluded the preheat beam and magnetic field to better characterize the implosion. X-ray self-emission as measured by framing cameras was used to determine the shell trajectory. The 1D code LILAC was used to model the central region of the implosion, and results were compared to 2D simulations from the HYDRA code. Post-processing of simulation output with SPECT3D and Yorick produced synthetic x-ray images that were used to compare the simulation results with the x-ray framing camera data. Quantitative analysis shows that higher measured neutron yields correlate with higher implosion velocities. The future goal is to further analyze the x-ray images to characterize the uniformity of the implosions and apply these analysis techniques to integrated laser-driven MagLIF shots to better understand the effects of preheat and the magnetic field.

  12. The devil is in the details: Comparisons of episodic simulations of positive and negative future events.

    PubMed

    Puig, Vannia A; Szpunar, Karl K

    2017-08-01

    Over the past decade, psychologists have devoted considerable attention to episodic simulation-the ability to imagine specific hypothetical events. Perhaps one of the most consistent patterns of data to emerge from this literature is that positive simulations of the future are rated as more detailed than negative simulations of the future, a pattern of results that is commonly interpreted as evidence for a positivity bias in future thinking. In the present article, we demonstrate across two experiments that negative future events are consistently simulated in more detail than positive future events when frequency of prior thinking is taken into account as a possible confounding variable and when level of detail associated with simulated events is assessed using an objective scoring criterion. Our findings are interpreted in the context of the mobilization-minimization hypothesis of event cognition that suggests people are especially likely to devote cognitive resources to processing negative scenarios. (PsycINFO Database Record (c) 2017 APA, all rights reserved).

  13. Laboratory Study on Disconnection Events in Comets

    NASA Astrophysics Data System (ADS)

    Li, Yan-Fei; Li, Yu-Tong; Wang, Wei-Min; Yuan, Da-Wei; et al.

    2018-01-01

    When comets interacting with solar wind, straight and narrow plasma tails will be often formed. The most remarkable phenomenon of the plasma tails is the disconnection event, in which a plasma tail is uprooted from the comet's head and moves away from the comet. In this paper, the interaction process between a comet and solar wind is simulated by using a laser-driven plasma cloud to hit a cylinder obstacle. A disconnected plasma tail is observed behind the obstacle by optical shadowgraphy and interferometry. Our particle-in-cell simulations show that the diference in thermal velocity between ions and electrons induces an electrostatic field behind the obstacle. This field can lead to the convergence of ions to the central region, resulting in a disconnected plasma tail. This electrostatic field-induced model may be a possible explanation for the disconnection events of cometary tails.

  14. An extension of the OpenModelica compiler for using Modelica models in a discrete event simulation

    DOE PAGES

    Nutaro, James

    2014-11-03

    In this article, a new back-end and run-time system is described for the OpenModelica compiler. This new back-end transforms a Modelica model into a module for the adevs discrete event simulation package, thereby extending adevs to encompass complex, hybrid dynamical systems. The new run-time system that has been built within the adevs simulation package supports models with state-events and time-events and that comprise differential-algebraic systems with high index. Finally, although the procedure for effecting this transformation is based on adevs and the Discrete Event System Specification, it can be adapted to any discrete event simulation package.

  15. Advanced Simulation of Coupled Earthquake and Tsunami Events

    NASA Astrophysics Data System (ADS)

    Behrens, Joern

    2013-04-01

    Tsunami-Earthquakes represent natural catastrophes threatening lives and well-being of societies in a solitary and unexpected extreme event as tragically demonstrated in Sumatra (2004), Samoa (2009), Chile (2010), or Japan (2011). Both phenomena are consequences of the complex system of interactions of tectonic stress, fracture mechanics, rock friction, rupture dynamics, fault geometry, ocean bathymetry, and coastline geometry. The ASCETE project forms an interdisciplinary research consortium that couples the most advanced simulation technologies for earthquake rupture dynamics and tsunami propagation to understand the fundamental conditions of tsunami generation. We report on the latest research results in physics-based dynamic rupture and tsunami wave propagation simulation, using unstructured and adaptive meshes with continuous and discontinuous Galerkin discretization approaches. Coupling both simulation tools - the physics-based dynamic rupture simulation and the hydrodynamic tsunami wave propagation - will give us the possibility to conduct highly realistic studies of the interaction of rupture dynamics and tsunami impact characteristics.

  16. Verification of gyrokinetic particle simulation of current-driven instability in fusion plasmas. I. Internal kink mode

    DOE Office of Scientific and Technical Information (OSTI.GOV)

    McClenaghan, J.; Lin, Z.; Holod, I.

    The gyrokinetic toroidal code (GTC) capability has been extended for simulating internal kink instability with kinetic effects in toroidal geometry. The global simulation domain covers the magnetic axis, which is necessary for simulating current-driven instabilities. GTC simulation in the fluid limit of the kink modes in cylindrical geometry is verified by benchmarking with a magnetohydrodynamic eigenvalue code. Gyrokinetic simulations of the kink modes in the toroidal geometry find that ion kinetic effects significantly reduce the growth rate even when the banana orbit width is much smaller than the radial width of the perturbed current layer at the mode rational surface.

  17. Analyzing depression tendency of web posts using an event-driven depression tendency warning model.

    PubMed

    Tung, Chiaming; Lu, Wenhsiang

    2016-01-01

    The Internet has become a platform to express individual moods/feelings of daily life, where authors share their thoughts in web blogs, micro-blogs, forums, bulletin board systems or other media. In this work, we investigate text-mining technology to analyze and predict the depression tendency of web posts. In this paper, we defined depression factors, which include negative events, negative emotions, symptoms, and negative thoughts from web posts. We proposed an enhanced event extraction (E3) method to automatically extract negative event terms. In addition, we also proposed an event-driven depression tendency warning (EDDTW) model to predict the depression tendency of web bloggers or post authors by analyzing their posted articles. We compare the performance among the proposed EDDTW model, negative emotion evaluation (NEE) model, and the diagnostic and statistical manual of mental disorders-based depression tendency evaluation method. The EDDTW model obtains the best recall rate and F-measure at 0.668 and 0.624, respectively, while the diagnostic and statistical manual of mental disorders-based method achieves the best precision rate of 0.666. The main reason is that our enhanced event extraction method can increase recall rate by enlarging the negative event lexicon at the expense of precision. Our EDDTW model can also be used to track the change or trend of depression tendency for each post author. The depression tendency trend can help doctors to diagnose and even track depression of web post authors more efficiently. This paper presents an E3 method to automatically extract negative event terms in web posts. We also proposed a new EDDTW model to predict the depression tendency of web posts and possibly help bloggers or post authors to early detect major depressive disorder. Copyright © 2015 Elsevier B.V. All rights reserved.

  18. A generalized two-fluid picture of non-driven collisionless reconnection and its relation to whistler waves

    DOE PAGES

    None, None

    2017-05-05

    A generalized, intuitive two-fluid picture of 2D non-driven collisionless magnetic reconnection is described using results from a full-3D numerical simulation. The relevant two-fluid equations simplify to the condition that the flux associated with canonical circulation Q=m e∇×u e+q eB is perfectly frozen into the electron fluid. In the reconnection geometry, flux tubes defined by Q are convected with the central electron current, effectively stretching the tubes and increasing the magnitude of Q exponentially. This, coupled with the fact that Q is a sum of two quantities, explains how the magnetic fields in the reconnection region reconnect and give rise tomore » strong electron acceleration. The Q motion provides an interpretation for other phenomena as well, such as spiked central electron current filaments. The simulated reconnection rate was found to agree with a previous analytical calculation having the same geometry. Energy analysis shows that the magnetic energy is converted and propagated mainly in the form of the Poynting flux, and helicity analysis shows that the canonical helicity ∫P·Q dV as a whole must be considered when analyzing reconnection. A mechanism for whistler wave generation and propagation is also described, with comparisons to recent spacecraft observations.« less

  19. Parallel discrete-event simulation of FCFS stochastic queueing networks

    NASA Technical Reports Server (NTRS)

    Nicol, David M.

    1988-01-01

    Physical systems are inherently parallel. Intuition suggests that simulations of these systems may be amenable to parallel execution. The parallel execution of a discrete-event simulation requires careful synchronization of processes in order to ensure the execution's correctness; this synchronization can degrade performance. Largely negative results were recently reported in a study which used a well-known synchronization method on queueing network simulations. Discussed here is a synchronization method (appointments), which has proven itself to be effective on simulations of FCFS queueing networks. The key concept behind appointments is the provision of lookahead. Lookahead is a prediction on a processor's future behavior, based on an analysis of the processor's simulation state. It is shown how lookahead can be computed for FCFS queueing network simulations, give performance data that demonstrates the method's effectiveness under moderate to heavy loads, and discuss performance tradeoffs between the quality of lookahead, and the cost of computing lookahead.

  20. Large-scale and Long-duration Simulation of a Multi-stage Eruptive Solar Event

    NASA Astrophysics Data System (ADS)

    Jiang, chaowei; Hu, Qiang; Wu, S. T.

    2015-04-01

    We employ a data-driven 3D MHD active region evolution model by using the Conservation Element and Solution Element (CESE) numerical method. This newly developed model retains the full MHD effects, allowing time-dependent boundary conditions and time evolution studies. The time-dependent simulation is driven by measured vector magnetograms and the method of MHD characteristics on the bottom boundary. We have applied the model to investigate the coronal magnetic field evolution of AR11283 which was characterized by a pre-existing sigmoid structure in the core region and multiple eruptions, both in relatively small and large scales. We have succeeded in producing the core magnetic field structure and the subsequent eruptions of flux-rope structures (see https://dl.dropboxusercontent.com/u/96898685/large.mp4 for an animation) as the measured vector magnetograms on the bottom boundary evolve in time with constant flux emergence. The whole process, lasting for about an hour in real time, compares well with the corresponding SDO/AIA and coronagraph imaging observations. From these results, we show the capability of the model, largely data-driven, that is able to simulate complex, topological, and highly dynamic active region evolutions. (We acknowledge partial support of NSF grants AGS 1153323 and AGS 1062050, and data support from SDO/HMI and AIA teams).

  1. Observation and simulation of an optically driven micromotor

    NASA Astrophysics Data System (ADS)

    Metzger, N. K.; Mazilu, M.; Kelemen, L.; Ormos, P.; Dholakia, K.

    2011-04-01

    In the realm of low Reynolds number flow there is a need to find methods to pump, move and mix minute amounts of analyte. Interestingly, micro-devices performing such actuation can be initiated by means of the light-matter interaction. Light induced forces and torques are exerted on such micro-objects, which are then driven by the optical gradient or scattering force. Here, different driving geometries can be realized to harness the light induced force. For example, the scattering force enables micro-gears to be operated in a tangential setup where the micromotor rotors are in line with an optical waveguide. The operational geometry we investigate has the advantage that it reduces the complexity of the driving of such a device in a microfluidic environment by delivering the actuating light by means of a waveguide or fiber optic. In this paper we explore the case of a micromotor being driven by a fiber optically delivered light beam. We experimentally investigate how the driving light interacts with and diffracts from the motor, utilizing two-photon imaging. The micromotor rotation rate dependence on the light field parameters is explored. Additionally, a theoretical model based on the paraxial approximation is used to simulate the torque and predict the rotation rate of such a device and compare it with experiment. The results presented show that our model can be used to optimize the micromotor performance and some example motor designs are evaluated.

  2. Simulation modelling of central order processing system under resource sharing strategy in demand-driven garment supply chains

    NASA Astrophysics Data System (ADS)

    Ma, K.; Thomassey, S.; Zeng, X.

    2017-10-01

    In this paper we proposed a central order processing system under resource sharing strategy for demand-driven garment supply chains to increase supply chain performances. We examined this system by using simulation technology. Simulation results showed that significant improvement in various performance indicators was obtained in new collaborative model with proposed system.

  3. Retrospective cost adaptive Reynolds-averaged Navier-Stokes k-ω model for data-driven unsteady turbulent simulations

    NASA Astrophysics Data System (ADS)

    Li, Zhiyong; Hoagg, Jesse B.; Martin, Alexandre; Bailey, Sean C. C.

    2018-03-01

    This paper presents a data-driven computational model for simulating unsteady turbulent flows, where sparse measurement data is available. The model uses the retrospective cost adaptation (RCA) algorithm to automatically adjust the closure coefficients of the Reynolds-averaged Navier-Stokes (RANS) k- ω turbulence equations to improve agreement between the simulated flow and the measurements. The RCA-RANS k- ω model is verified for steady flow using a pipe-flow test case and for unsteady flow using a surface-mounted-cube test case. Measurements used for adaptation of the verification cases are obtained from baseline simulations with known closure coefficients. These verification test cases demonstrate that the RCA-RANS k- ω model can successfully adapt the closure coefficients to improve agreement between the simulated flow field and a set of sparse flow-field measurements. Furthermore, the RCA-RANS k- ω model improves agreement between the simulated flow and the baseline flow at locations at which measurements do not exist. The RCA-RANS k- ω model is also validated with experimental data from 2 test cases: steady pipe flow, and unsteady flow past a square cylinder. In both test cases, the adaptation improves agreement with experimental data in comparison to the results from a non-adaptive RANS k- ω model that uses the standard values of the k- ω closure coefficients. For the steady pipe flow, adaptation is driven by mean stream-wise velocity measurements at 24 locations along the pipe radius. The RCA-RANS k- ω model reduces the average velocity error at these locations by over 35%. For the unsteady flow over a square cylinder, adaptation is driven by time-varying surface pressure measurements at 2 locations on the square cylinder. The RCA-RANS k- ω model reduces the average surface-pressure error at these locations by 88.8%.

  4. Dynamic Structure Factor and Transport Coefficients of a Homogeneously Driven Granular Fluid in Steady State

    NASA Astrophysics Data System (ADS)

    Vollmayr-Lee, Katharina; Zippelius, Annette; Aspelmeier, Timo

    2011-03-01

    We study the dynamic structure factor of a granular fluid of hard spheres, driven into a stationary nonequilibrium state by balancing the energy loss due to inelastic collisions with the energy input due to driving. The driving is chosen to conserve momentum, so that fluctuating hydrodynamics predicts the existence of sound modes. We present results of computer simulations which are based on an event driven algorithm. The dynamic structure factor F (q , ω) is determined for volume fractions 0.05, 0.1 and 0.2 and coefficients of normal restitution 0.8 and 0.9. We observe sound waves, and compare our results for F (q , ω) with the predictions of generalized fluctuating hydrodynamics which takes into account that temperature fluctuations decay either diffusively or with a finite relaxation rate, depending on wave number and inelasticity. We determine the speed of sound and the transport coefficients and compare them to the results of kinetic theory. K.V.L. thanks the Institute of Theoretical Physics, University of Goettingen, for financial support and hospitality.

  5. BAYESIAN TECHNIQUES FOR COMPARING TIME-DEPENDENT GRMHD SIMULATIONS TO VARIABLE EVENT HORIZON TELESCOPE OBSERVATIONS

    DOE Office of Scientific and Technical Information (OSTI.GOV)

    Kim, Junhan; Marrone, Daniel P.; Chan, Chi-Kwan

    2016-12-01

    The Event Horizon Telescope (EHT) is a millimeter-wavelength, very-long-baseline interferometry (VLBI) experiment that is capable of observing black holes with horizon-scale resolution. Early observations have revealed variable horizon-scale emission in the Galactic Center black hole, Sagittarius A* (Sgr A*). Comparing such observations to time-dependent general relativistic magnetohydrodynamic (GRMHD) simulations requires statistical tools that explicitly consider the variability in both the data and the models. We develop here a Bayesian method to compare time-resolved simulation images to variable VLBI data, in order to infer model parameters and perform model comparisons. We use mock EHT data based on GRMHD simulations to explore themore » robustness of this Bayesian method and contrast it to approaches that do not consider the effects of variability. We find that time-independent models lead to offset values of the inferred parameters with artificially reduced uncertainties. Moreover, neglecting the variability in the data and the models often leads to erroneous model selections. We finally apply our method to the early EHT data on Sgr A*.« less

  6. Bayesian Techniques for Comparing Time-dependent GRMHD Simulations to Variable Event Horizon Telescope Observations

    NASA Astrophysics Data System (ADS)

    Kim, Junhan; Marrone, Daniel P.; Chan, Chi-Kwan; Medeiros, Lia; Özel, Feryal; Psaltis, Dimitrios

    2016-12-01

    The Event Horizon Telescope (EHT) is a millimeter-wavelength, very-long-baseline interferometry (VLBI) experiment that is capable of observing black holes with horizon-scale resolution. Early observations have revealed variable horizon-scale emission in the Galactic Center black hole, Sagittarius A* (Sgr A*). Comparing such observations to time-dependent general relativistic magnetohydrodynamic (GRMHD) simulations requires statistical tools that explicitly consider the variability in both the data and the models. We develop here a Bayesian method to compare time-resolved simulation images to variable VLBI data, in order to infer model parameters and perform model comparisons. We use mock EHT data based on GRMHD simulations to explore the robustness of this Bayesian method and contrast it to approaches that do not consider the effects of variability. We find that time-independent models lead to offset values of the inferred parameters with artificially reduced uncertainties. Moreover, neglecting the variability in the data and the models often leads to erroneous model selections. We finally apply our method to the early EHT data on Sgr A*.

  7. Simulating and Forecasting Flooding Events in the City of Jeddah, Saudi Arabia

    NASA Astrophysics Data System (ADS)

    Ghostine, Rabih; Viswanadhapalli, Yesubabu; Hoteit, Ibrahim

    2014-05-01

    Metropolitan cities in the Kingdom of Saudi Arabia, as Jeddah and Riyadh, are more frequently experiencing flooding events caused by strong convective storms that produce intense precipitation over a short span of time. The flooding in the city of Jeddah in November 2009 was described by civil defense officials as the worst in 27 years. As of January 2010, 150 people were reported killed and more than 350 were missing. Another flooding event, less damaging but comparably spectacular, occurred one year later (Jan 2011) in Jeddah. Anticipating floods before they occur could minimize human and economic losses through the implementation of appropriate protection, provision and rescue plans. We have developed a coupled hydro-meteorological model for simulating and predicting flooding events in the city of Jeddah. We use the Weather Research Forecasting (WRF) model assimilating all available data in the Jeddah region for simulating the storm events in Jeddah. The resulting rain is then used on 10 minutes intervals to feed up an advanced numerical shallow water model that has been discretized on an unstructured grid using different numerical schemes based on the finite elements or finite volume techniques. The model was integrated on a high-resolution grid size varying between 0.5m within the streets of Jeddah and 500m outside the city. This contribution will present the flooding simulation system and the simulation results, focusing on the comparison of the different numerical schemes on the system performances in terms of accuracy and computational efficiency.

  8. A Coupled Earthquake-Tsunami Simulation Framework Applied to the Sumatra 2004 Event

    NASA Astrophysics Data System (ADS)

    Vater, Stefan; Bader, Michael; Behrens, Jörn; van Dinther, Ylona; Gabriel, Alice-Agnes; Madden, Elizabeth H.; Ulrich, Thomas; Uphoff, Carsten; Wollherr, Stephanie; van Zelst, Iris

    2017-04-01

    Large earthquakes along subduction zone interfaces have generated destructive tsunamis near Chile in 1960, Sumatra in 2004, and northeast Japan in 2011. In order to better understand these extreme events, we have developed tools for physics-based, coupled earthquake-tsunami simulations. This simulation framework is applied to the 2004 Indian Ocean M 9.1-9.3 earthquake and tsunami, a devastating event that resulted in the loss of more than 230,000 lives. The earthquake rupture simulation is performed using an ADER discontinuous Galerkin discretization on an unstructured tetrahedral mesh with the software SeisSol. Advantages of this approach include accurate representation of complex fault and sea floor geometries and a parallelized and efficient workflow in high-performance computing environments. Accurate and efficient representation of the tsunami evolution and inundation at the coast is achieved with an adaptive mesh discretizing the shallow water equations with a second-order Runge-Kutta discontinuous Galerkin (RKDG) scheme. With the application of the framework to this historic event, we aim to better understand the involved mechanisms between the dynamic earthquake within the earth's crust, the resulting tsunami wave within the ocean, and the final coastal inundation process. Earthquake model results are constrained by GPS surface displacements and tsunami model results are compared with buoy and inundation data. This research is part of the ASCETE Project, "Advanced Simulation of Coupled Earthquake and Tsunami Events", funded by the Volkswagen Foundation.

  9. Examining Passenger Flow Choke Points at Airports Using Discrete Event Simulation

    NASA Technical Reports Server (NTRS)

    Brown, Jeremy R.; Madhavan, Poomima

    2011-01-01

    The movement of passengers through an airport quickly, safely, and efficiently is the main function of the various checkpoints (check-in, security. etc) found in airports. Human error combined with other breakdowns in the complex system of the airport can disrupt passenger flow through the airport leading to lengthy waiting times, missing luggage and missed flights. In this paper we present a model of passenger flow through an airport using discrete event simulation that will provide a closer look into the possible reasons for breakdowns and their implications for passenger flow. The simulation is based on data collected at Norfolk International Airport (ORF). The primary goal of this simulation is to present ways to optimize the work force to keep passenger flow smooth even during peak travel times and for emergency preparedness at ORF in case of adverse events. In this simulation we ran three different scenarios: real world, increased check-in stations, and multiple waiting lines. Increased check-in stations increased waiting time and instantaneous utilization. while the multiple waiting lines decreased both the waiting time and instantaneous utilization. This simulation was able to show how different changes affected the passenger flow through the airport.

  10. Advances in Discrete-Event Simulation for MSL Command Validation

    NASA Technical Reports Server (NTRS)

    Patrikalakis, Alexander; O'Reilly, Taifun

    2013-01-01

    In the last five years, the discrete event simulator, SEQuence GENerator (SEQGEN), developed at the Jet Propulsion Laboratory to plan deep-space missions, has greatly increased uplink operations capacity to deal with increasingly complicated missions. In this paper, we describe how the Mars Science Laboratory (MSL) project makes full use of an interpreted environment to simulate change in more than fifty thousand flight software parameters and conditional command sequences to predict the result of executing a conditional branch in a command sequence, and enable the ability to warn users whenever one or more simulated spacecraft states change in an unexpected manner. Using these new SEQGEN features, operators plan more activities in one sol than ever before.

  11. Constraints on Cumulus Parameterization from Simulations of Observed MJO Events

    NASA Technical Reports Server (NTRS)

    Del Genio, Anthony; Wu, Jingbo; Wolf, Audrey B.; Chen, Yonghua; Yao, Mao-Sung; Kim, Daehyun

    2015-01-01

    Two recent activities offer an opportunity to test general circulation model (GCM) convection and its interaction with large-scale dynamics for observed Madden-Julian oscillation (MJO) events. This study evaluates the sensitivity of the Goddard Institute for Space Studies (GISS) GCM to entrainment, rain evaporation, downdrafts, and cold pools. Single Column Model versions that restrict weakly entraining convection produce the most realistic dependence of convection depth on column water vapor (CWV) during the Atmospheric Radiation Measurement MJO Investigation Experiment at Gan Island. Differences among models are primarily at intermediate CWV where the transition from shallow to deeper convection occurs. GCM 20-day hindcasts during the Year of Tropical Convection that best capture the shallow–deep transition also produce strong MJOs, with significant predictability compared to Tropical Rainfall Measuring Mission data. The dry anomaly east of the disturbance on hindcast day 1 is a good predictor of MJO onset and evolution. Initial CWV there is near the shallow–deep transition point, implicating premature onset of deep convection as a predictor of a poor MJO simulation. Convection weakly moistens the dry region in good MJO simulations in the first week; weakening of large-scale subsidence over this time may also affect MJO onset. Longwave radiation anomalies are weakest in the worst model version, consistent with previous analyses of cloud/moisture greenhouse enhancement as the primary MJO energy source. The authors’ results suggest that both cloud-/moisture-radiative interactions and convection–moisture sensitivity are required to produce a successful MJO simulation.

  12. Data driven analysis of rain events: feature extraction, clustering, microphysical /macro physical relationship

    NASA Astrophysics Data System (ADS)

    Djallel Dilmi, Mohamed; Mallet, Cécile; Barthes, Laurent; Chazottes, Aymeric

    2017-04-01

    that a rain time series can be considered by an alternation of independent rain event and no rain period. The five selected feature are used to perform a hierarchical clustering of the events. The well-known division between stratiform and convective events appears clearly. This classification into two classes is then refined in 5 fairly homogeneous subclasses. The data driven analysis performed on whole rain events instead of fixed length samples allows identifying strong relationships between macrophysics (based on rain rate) and microphysics (based on raindrops) features. We show that among the 5 identified subclasses some of them have specific microphysics characteristics. Obtaining information on microphysical characteristics of rainfall events from rain gauges measurement suggests many implications in development of the quantitative precipitation estimation (QPE), for the improvement of rain rate retrieval algorithm in remote sensing context.

  13. Joint independent component analysis for simultaneous EEG-fMRI: principle and simulation.

    PubMed

    Moosmann, Matthias; Eichele, Tom; Nordby, Helge; Hugdahl, Kenneth; Calhoun, Vince D

    2008-03-01

    An optimized scheme for the fusion of electroencephalography and event related potentials with functional magnetic resonance imaging (BOLD-fMRI) data should simultaneously assess all available electrophysiologic and hemodynamic information in a common data space. In doing so, it should be possible to identify features of latent neural sources whose trial-to-trial dynamics are jointly reflected in both modalities. We present a joint independent component analysis (jICA) model for analysis of simultaneous single trial EEG-fMRI measurements from multiple subjects. We outline the general idea underlying the jICA approach and present results from simulated data under realistic noise conditions. Our results indicate that this approach is a feasible and physiologically plausible data-driven way to achieve spatiotemporal mapping of event related responses in the human brain.

  14. Reading sky and seeing a cloud: On the relevance of events for perceptual simulation.

    PubMed

    Ostarek, Markus; Vigliocco, Gabriella

    2017-04-01

    Previous research has shown that processing words with an up/down association (e.g., bird, foot) can influence the subsequent identification of visual targets in congruent location (at the top/bottom of the screen). However, as facilitation and interference were found under similar conditions, the nature of the underlying mechanisms remained unclear. We propose that word comprehension relies on the perceptual simulation of a prototypical event involving the entity denoted by a word in order to provide a general account of the different findings. In 3 experiments, participants had to discriminate between 2 target pictures appearing at the top or the bottom of the screen by pressing the left versus right button. Immediately before the targets appeared, they saw an up/down word belonging to the target's event, an up/down word unrelated to the target, or a spatially neutral control word. Prime words belonging to target event facilitated identification of targets at a stimulus onset asynchrony (SOA) of 250 ms (Experiment 1), but only when presented in the vertical location where they are typically seen, indicating that targets were integrated in the simulations activated by the prime words. Moreover, at the same SOA, there was a robust facilitation effect for targets appearing in their typical location regardless of the prime type. However, when words were presented for 100 ms (Experiment 2) or 800 ms (Experiment 3), only a location nonspecific priming effect was found, suggesting that the visual system was not activated. Implications for theories of semantic processing are discussed. (PsycINFO Database Record (c) 2017 APA, all rights reserved).

  15. Towards Data-Driven Simulations of Wildfire Spread using Ensemble-based Data Assimilation

    NASA Astrophysics Data System (ADS)

    Rochoux, M. C.; Bart, J.; Ricci, S. M.; Cuenot, B.; Trouvé, A.; Duchaine, F.; Morel, T.

    2012-12-01

    Real-time predictions of a propagating wildfire remain a challenging task because the problem involves both multi-physics and multi-scales. The propagation speed of wildfires, also called the rate of spread (ROS), is indeed determined by complex interactions between pyrolysis, combustion and flow dynamics, atmospheric dynamics occurring at vegetation, topographical and meteorological scales. Current operational fire spread models are mainly based on a semi-empirical parameterization of the ROS in terms of vegetation, topographical and meteorological properties. For the fire spread simulation to be predictive and compatible with operational applications, the uncertainty on the ROS model should be reduced. As recent progress made in remote sensing technology provides new ways to monitor the fire front position, a promising approach to overcome the difficulties found in wildfire spread simulations is to integrate fire modeling and fire sensing technologies using data assimilation (DA). For this purpose we have developed a prototype data-driven wildfire spread simulator in order to provide optimal estimates of poorly known model parameters [*]. The data-driven simulation capability is adapted for more realistic wildfire spread : it considers a regional-scale fire spread model that is informed by observations of the fire front location. An Ensemble Kalman Filter algorithm (EnKF) based on a parallel computing platform (OpenPALM) was implemented in order to perform a multi-parameter sequential estimation where wind magnitude and direction are in addition to vegetation properties (see attached figure). The EnKF algorithm shows its good ability to track a small-scale grassland fire experiment and ensures a good accounting for the sensitivity of the simulation outcomes to the control parameters. As a conclusion, it was shown that data assimilation is a promising approach to more accurately forecast time-varying wildfire spread conditions as new airborne-like observations of

  16. Near Optimal Event-Triggered Control of Nonlinear Discrete-Time Systems Using Neurodynamic Programming.

    PubMed

    Sahoo, Avimanyu; Xu, Hao; Jagannathan, Sarangapani

    2016-09-01

    This paper presents an event-triggered near optimal control of uncertain nonlinear discrete-time systems. Event-driven neurodynamic programming (NDP) is utilized to design the control policy. A neural network (NN)-based identifier, with event-based state and input vectors, is utilized to learn the system dynamics. An actor-critic framework is used to learn the cost function and the optimal control input. The NN weights of the identifier, the critic, and the actor NNs are tuned aperiodically once every triggered instant. An adaptive event-trigger condition to decide the trigger instants is derived. Thus, a suitable number of events are generated to ensure a desired accuracy of approximation. A near optimal performance is achieved without using value and/or policy iterations. A detailed analysis of nontrivial inter-event times with an explicit formula to show the reduction in computation is also derived. The Lyapunov technique is used in conjunction with the event-trigger condition to guarantee the ultimate boundedness of the closed-loop system. The simulation results are included to verify the performance of the controller. The net result is the development of event-driven NDP.

  17. The added value of convection permitting simulations of extreme precipitation events over the eastern Mediterranean

    NASA Astrophysics Data System (ADS)

    Zittis, G.; Bruggeman, A.; Camera, C.; Hadjinicolaou, P.; Lelieveld, J.

    2017-07-01

    Climate change is expected to substantially influence precipitation amounts and distribution. To improve simulations of extreme rainfall events, we analyzed the performance of different convection and microphysics parameterizations of the WRF (Weather Research and Forecasting) model at very high horizontal resolutions (12, 4 and 1 km). Our study focused on the eastern Mediterranean climate change hot-spot. Five extreme rainfall events over Cyprus were identified from observations and were dynamically downscaled from the ERA-Interim (EI) dataset with WRF. We applied an objective ranking scheme, using a 1-km gridded observational dataset over Cyprus and six different performance metrics, to investigate the skill of the WRF configurations. We evaluated the rainfall timing and amounts for the different resolutions, and discussed the observational uncertainty over the particular extreme events by comparing three gridded precipitation datasets (E-OBS, APHRODITE and CHIRPS). Simulations with WRF capture rainfall over the eastern Mediterranean reasonably well for three of the five selected extreme events. For these three cases, the WRF simulations improved the ERA-Interim data, which strongly underestimate the rainfall extremes over Cyprus. The best model performance is obtained for the January 1989 event, simulated with an average bias of 4% and a modified Nash-Sutcliff of 0.72 for the 5-member ensemble of the 1-km simulations. We found overall added value for the convection-permitting simulations, especially over regions of high-elevation. Interestingly, for some cases the intermediate 4-km nest was found to outperform the 1-km simulations for low-elevation coastal parts of Cyprus. Finally, we identified significant and inconsistent discrepancies between the three, state of the art, gridded precipitation datasets for the tested events, highlighting the observational uncertainty in the region.

  18. Abaqus Simulations of Rock Response to Dynamic Loading

    DOE Office of Scientific and Technical Information (OSTI.GOV)

    Steedman, David W.; Coblentz, David

    The LANL Geodynamics Team has been applying Abaqus modeling to achieve increasingly complex simulations. Advancements in Abaqus model building and simulation tools allows this progress. We use Lab-developed constitutive models, the fully coupled CEL Abaqus and general contact to simulate response of realistic sites to explosively driven shock.

  19. Simulation of Ionospheric Response During Solar Eclipse Events

    NASA Astrophysics Data System (ADS)

    Kordella, L.; Earle, G. D.; Huba, J.

    2016-12-01

    Total solar eclipses are rare, short duration events that present interesting case studies of ionospheric behavior because the structure of the ionosphere is determined and stabilized by varying energies of solar radiation (Lyman alpha, X-ray, U.V., etc.). The ionospheric response to eclipse events is a source of scientific intrigue that has been studied in various capacities over the past 50 years. Unlike the daily terminator crossings, eclipses cause highly localized, steep gradients of ionization efficiency due to their comparatively small solar zenith angle. However, the corona remains present even at full obscuration, meaning that the energy reduction never falls to the levels seen at night. Previous eclipse studies performed by research groups in the US, UK, China and Russia have shown a range of effects, some counter-intuitive and others contradictory. In the shadowed region of an eclipse (i.e. umbra) it is logical to assume a reduction in ionization rates correlating with the reduction of incident solar radiation. Results have shown that even this straightforward hypothesis may not be true; effects on plasma distribution, motion and temperature are more appreciable than might be expected. Recent advancements in ionospheric simulation codes present the opportunity to investigate the relationship between geophysical conditions and geomagnetic location on resulting eclipse event ionosphere. Here we present computational simulation results using the Naval Research Lab (NRL) developed ionospheric modeling codes Sami2 and Sami3 (Sami2 is Another Model of the Ionosphere) modified with spatio-temporal photoionization attenuation functions derived from theory and empirical data.

  20. Event-based simulation of networks with pulse delayed coupling

    NASA Astrophysics Data System (ADS)

    Klinshov, Vladimir; Nekorkin, Vladimir

    2017-10-01

    Pulse-mediated interactions are common in networks of different nature. Here we develop a general framework for simulation of networks with pulse delayed coupling. We introduce the discrete map governing the dynamics of such networks and describe the computation algorithm for its numerical simulation.

  1. Deployment and retraction of a cable-driven solar array: Testing and simulation

    NASA Technical Reports Server (NTRS)

    Kumar, P.; Pellegrino, S.

    1995-01-01

    The paper investigates three critical areas in cable-driven rigid-panel solar arrays: First, the variation of deployment and retraction cable tensions due to friction at the hinges; Second, the change in deployment dynamics associated with different deployment histories; Third, the relationship between the level of pre-tension in the closed contact loops and the synchronization of deployment. A small scale model array has been made and tested, and its behavior has been compared to numerical simulations.

  2. Measuring implosion velocities in experiments and simulations of laser-driven cylindrical implosions on the OMEGA laser

    DOE Office of Scientific and Technical Information (OSTI.GOV)

    Hansen, E. C.; Barnak, D. H.; Betti, R.

    Laser-driven magnetized liner inertial fusion (MagLIF) on OMEGA involves cylindrical implosions, a preheat beam, and an applied magnetic field. Initial experiments excluded the preheat beam and magnetic field to better characterize the implosion. X-ray self-emission as measured by framing cameras was used to determine the shell trajectory. The 1-D code LILAC was used to model the central region of the implosion, and results were compared to 2-D simulations from the HYDRA code. Post-processing of simulation output with SPECT3D and Yorick produced synthetic x-ray images that were used to compare the simulation results with the x-ray framing camera data. Quantitative analysismore » shows that higher measured neutron yields correlate with higher implosion velocities. The future goal is to further analyze the x-ray images to characterize the uniformity of the implosions and apply these analysis techniques to integrated laser-driven MagLIF shots to better understand the effects of preheat and the magnetic field.« less

  3. Measuring implosion velocities in experiments and simulations of laser-driven cylindrical implosions on the OMEGA laser

    DOE PAGES

    Hansen, E. C.; Barnak, D. H.; Betti, R.; ...

    2018-04-04

    Laser-driven magnetized liner inertial fusion (MagLIF) on OMEGA involves cylindrical implosions, a preheat beam, and an applied magnetic field. Initial experiments excluded the preheat beam and magnetic field to better characterize the implosion. X-ray self-emission as measured by framing cameras was used to determine the shell trajectory. The 1-D code LILAC was used to model the central region of the implosion, and results were compared to 2-D simulations from the HYDRA code. Post-processing of simulation output with SPECT3D and Yorick produced synthetic x-ray images that were used to compare the simulation results with the x-ray framing camera data. Quantitative analysismore » shows that higher measured neutron yields correlate with higher implosion velocities. The future goal is to further analyze the x-ray images to characterize the uniformity of the implosions and apply these analysis techniques to integrated laser-driven MagLIF shots to better understand the effects of preheat and the magnetic field.« less

  4. General Purpose Data-Driven Online System Health Monitoring with Applications to Space Operations

    NASA Technical Reports Server (NTRS)

    Iverson, David L.; Spirkovska, Lilly; Schwabacher, Mark

    2010-01-01

    Modern space transportation and ground support system designs are becoming increasingly sophisticated and complex. Determining the health state of these systems using traditional parameter limit checking, or model-based or rule-based methods is becoming more difficult as the number of sensors and component interactions grows. Data-driven monitoring techniques have been developed to address these issues by analyzing system operations data to automatically characterize normal system behavior. System health can be monitored by comparing real-time operating data with these nominal characterizations, providing detection of anomalous data signatures indicative of system faults, failures, or precursors of significant failures. The Inductive Monitoring System (IMS) is a general purpose, data-driven system health monitoring software tool that has been successfully applied to several aerospace applications and is under evaluation for anomaly detection in vehicle and ground equipment for next generation launch systems. After an introduction to IMS application development, we discuss these NASA online monitoring applications, including the integration of IMS with complementary model-based and rule-based methods. Although the examples presented in this paper are from space operations applications, IMS is a general-purpose health-monitoring tool that is also applicable to power generation and transmission system monitoring.

  5. Fluid simulation of relativistic electron beam driven wakefield in a cold plasma

    DOE Office of Scientific and Technical Information (OSTI.GOV)

    Bera, Ratan Kumar; Sengupta, Sudip; Das, Amita

    Excitation of wakefield in a cold homogeneous plasma, driven by an ultra-relativistic electron beam is studied in one dimension using fluid simulation techniques. For a homogeneous rigid beam having density (n{sub b}) less than or equal to half the plasma density (n{sub 0}), simulation results are found to be in good agreement with the analytical work of Rosenzweig [Phys. Rev. Lett. 58, 555 (1987)]. Here, Rosenzweig's work has been analytically extended to regimes where the ratio of beam density to plasma density is greater than half and results have been verified using simulation. Further in contrast to Rosenzweig's work, ifmore » the beam is allowed to evolve in a self-consistent manner, several interesting features are observed in simulation viz. splitting of the beam into beam-lets (for l{sub b} > λ{sub p}) and compression of the beam (for l{sub b} < λ{sub p}), l{sub b} and λ{sub p}, respectively, being the initial beam length and plasma wavelength.« less

  6. Benchmarking shielding simulations for an accelerator-driven spallation neutron source

    DOE PAGES

    Cherkashyna, Nataliia; Di Julio, Douglas D.; Panzner, Tobias; ...

    2015-08-09

    The shielding at an accelerator-driven spallation neutron facility plays a critical role in the performance of the neutron scattering instruments, the overall safety, and the total cost of the facility. Accurate simulation of shielding components is thus key for the design of upcoming facilities, such as the European Spallation Source (ESS), currently in construction in Lund, Sweden. In this paper, we present a comparative study between the measured and the simulated neutron background at the Swiss Spallation Neutron Source (SINQ), at the Paul Scherrer Institute (PSI), Villigen, Switzerland. The measurements were carried out at several positions along the SINQ monolithmore » wall with the neutron dosimeter WENDI-2, which has a well-characterized response up to 5 GeV. The simulations were performed using the Monte-Carlo radiation transport code Geant4, and include a complete transport from the proton beam to the measurement locations in a single calculation. An agreement between measurements and simulations is about a factor of 2 for the points where the measured radiation dose is above the background level, which is a satisfactory result for such simulations spanning many energy regimes, different physics processes and transport through several meters of shielding materials. The neutrons contributing to the radiation field emanating from the monolith were confirmed to originate from neutrons with energies above 1 MeV in the target region. The current work validates Geant4 as being well suited for deep-shielding calculations at accelerator-based spallation sources. We also extrapolate what the simulated flux levels might imply for short (several tens of meters) instruments at ESS.« less

  7. Adoption of Test Driven Development and Continuous Integration for the Development of the Trick Simulation Toolkit

    NASA Technical Reports Server (NTRS)

    Penn, John M.

    2013-01-01

    This paper describes the adoption of a Test Driven Development approach and a Continuous Integration System in the development of the Trick Simulation Toolkit, a generic simulation development environment for creating high fidelity training and engineering simulations at the NASA/Johnson Space Center and many other NASA facilities. It describes what was learned and the significant benefits seen, such as fast, thorough, and clear test feedback every time code is checked-in to the code repository. It also describes a system that encourages development of code that is much more flexible, maintainable, and reliable. The Trick Simulation Toolkit development environment provides a common architecture for user-defined simulations. Trick builds executable simulations using user-supplied simulation-definition files (S_define) and user supplied "model code". For each Trick-based simulation, Trick automatically provides job scheduling, checkpoint / restore, data-recording, interactive variable manipulation (variable server), and an input-processor. Also included are tools for plotting recorded data and various other supporting tools and libraries. Trick is written in C/C++ and Java and supports both Linux and MacOSX. Prior to adopting this new development approach, Trick testing consisted primarily of running a few large simulations, with the hope that their complexity and scale would exercise most of Trick's code and expose any recently introduced bugs. Unsurprising, this approach yielded inconsistent results. It was obvious that a more systematic, thorough approach was required. After seeing examples of some Java-based projects that used the JUnit test framework, similar test frameworks for C and C++ were sought. Several were found, all clearly inspired by JUnit. Googletest, a freely available Open source testing framework, was selected as the most appropriate and capable. The new approach was implemented while rewriting the Trick memory management component, to eliminate a

  8. Gyrokinetic Simulations of Transport Scaling and Structure

    NASA Astrophysics Data System (ADS)

    Hahm, Taik Soo

    2001-10-01

    There is accumulating evidence from global gyrokinetic particle simulations with profile variations and experimental fluctuation measurements that microturbulence, with its time-averaged eddy size which scales with the ion gyroradius, can cause ion thermal transport which deviates from the gyro-Bohm scaling. The physics here can be best addressed by large scale (rho* = rho_i/a = 0.001) full torus gyrokinetic particle-in-cell turbulence simulations using our massively parallel, general geometry gyrokinetic toroidal code with field-aligned mesh. Simulation results from device-size scans for realistic parameters show that ``wave transport'' mechanism is not the dominant contribution for this Bohm-like transport and that transport is mostly diffusive driven by microscopic scale fluctuations in the presence of self-generated zonal flows. In this work, we analyze the turbulence and zonal flow statistics from simulations and compare to nonlinear theoretical predictions including the radial decorrelation of the transport events by zonal flows and the resulting probability distribution function (PDF). In particular, possible deviation of the characteristic radial size of transport processes from the time-averaged radial size of the density fluctuation eddys will be critically examined.

  9. Muscle-driven finite element simulation of human foot movements.

    PubMed

    Spyrou, L A; Aravas, N

    2012-01-01

    This paper describes a finite element scheme for realistic muscle-driven simulation of human foot movements. The scheme is used to simulate human ankle plantar flexion. A three-dimensional anatomically detailed finite element model of human foot and lower leg is developed and the idea of generating natural foot movement based entirely on the contraction of the plantar flexor muscles is used. The bones, ligaments, articular cartilage, muscles, tendons, as well as the rest soft tissues of human foot and lower leg are included in the model. A realistic three-dimensional continuum constitutive model that describes the biomechanical behaviour of muscles and tendons is used. Both the active and passive properties of muscle tissue are accounted for. The materials for bones and ligaments are considered as homogeneous, isotropic and linearly elastic, whereas the articular cartilage and the rest soft tissues (mainly fat) are defined as hyperelastic materials. The model is used to estimate muscle tissue deformations as well as stresses and strains that develop in the lower leg muscles during plantar flexion of the ankle. Stresses and strains that develop in Achilles tendon during such a movement are also investigated.

  10. Dynamic simulations of under-rib convection-driven flow-field configurations and comparison with experiment in polymer electrolyte membrane fuel cells

    NASA Astrophysics Data System (ADS)

    Duy, Vinh Nguyen; Lee, Jungkoo; Kim, Kyungcheol; Ahn, Jiwoong; Park, Seongho; Kim, Taeeun; Kim, Hyung-Man

    2015-10-01

    The under-rib convection-driven flow-field design for the uniform distribution of reacting gas and the generation of produced water generates broad scientific interest, especially among those who study the performance of polymer electrolyte membrane fuel cells (PEMFCs). In this study, we simulate the effects of an under-rib convection-driven serpentine flow-field with sub-channel and by-pass (SFFSB) and a conventional advanced serpentine flow-field (CASFF) on single cell performance, and we compare the simulation results with experimental measurements. In the under-rib convection-driven flow-field configuration with SFFSB, the pressure drop is decreased because of the greater cross-sectional area for gas flow, and the decreased pressure drop results in the reduction of the parasitic loss. The anode liquid water mass fraction increases with increasing channel height because of increased back diffusion, while the cathode liquid water mass fraction does not depend upon the sub-channels but is ascribed mainly to the electro-osmotic drag. Simulation results verify that the maximum current and the power densities of the SFFSB are increased by 18.85% and 23.74%, respectively, due to the promotion of under-rib convection. The findings in this work may enable the optimization of the design of under-rib convection-driven flow-fields for efficient PEMFCs.

  11. MoSeS: Modelling and Simulation for e-Social Science.

    PubMed

    Townend, Paul; Xu, Jie; Birkin, Mark; Turner, Andy; Wu, Belinda

    2009-07-13

    MoSeS (Modelling and Simulation for e-Social Science) is a research node of the National Centre for e-Social Science. MoSeS uses e-Science techniques to execute an events-driven model that simulates discrete demographic processes; this allows us to project the UK population 25 years into the future. This paper describes the architecture, simulation methodology and latest results obtained by MoSeS.

  12. ON THE IMPACT OF THREE DIMENSIONS IN SIMULATIONS OF NEUTRINO-DRIVEN CORE-COLLAPSE SUPERNOVA EXPLOSIONS

    DOE Office of Scientific and Technical Information (OSTI.GOV)

    Couch, Sean M., E-mail: smc@flash.uchicago.edu

    2013-09-20

    We present one-dimensional (1D), two-dimensional (2D), and three-dimensional (3D) hydrodynamical simulations of core-collapse supernovae including a parameterized neutrino heating and cooling scheme in order to investigate the critical core neutrino luminosity (L{sub crit}) required for explosion. In contrast to some previous works, we find that 3D simulations explode later than 2D simulations, and that L{sub crit} at fixed mass accretion rate is somewhat higher in three dimensions than in two dimensions. We find, however, that in two dimensions L{sub crit} increases as the numerical resolution of the simulation increases. In contrast to some previous works, we argue that the averagemore » entropy of the gain region is in fact not a good indicator of explosion but is rather a reflection of the greater mass in the gain region in two dimensions. We compare our simulations to semi-analytic explosion criteria and examine the nature of the convective motions in two dimensions and three dimensions. We discuss the balance between neutrino-driven buoyancy and drag forces. In particular, we show that the drag force will be proportional to a buoyant plume's surface area while the buoyant force is proportional to a plume's volume and, therefore, plumes with greater volume-to-surface-area ratios will rise more quickly. We show that buoyant plumes in two dimensions are inherently larger, with greater volume-to-surface-area ratios, than plumes in three dimensions. In the scenario that the supernova shock expansion is dominated by neutrino-driven buoyancy, this balance between buoyancy and drag forces may explain why 3D simulations explode later than 2D simulations and why L{sub crit} increases with resolution. Finally, we provide a comparison of our results with other calculations in the literature.« less

  13. A simulative comparison of respondent driven sampling with incentivized snowball sampling – the “strudel effect”

    PubMed Central

    Gyarmathy, V. Anna; Johnston, Lisa G.; Caplinskiene, Irma; Caplinskas, Saulius; Latkin, Carl A.

    2014-01-01

    Background Respondent driven sampling (RDS) and Incentivized Snowball Sampling (ISS) are two sampling methods that are commonly used to reach people who inject drugs (PWID). Methods We generated a set of simulated RDS samples on an actual sociometric ISS sample of PWID in Vilnius, Lithuania (“original sample”) to assess if the simulated RDS estimates were statistically significantly different from the original ISS sample prevalences for HIV (9.8%), Hepatitis A (43.6%), Hepatitis B (Anti-HBc 43.9% and HBsAg 3.4%), Hepatitis C (87.5%), syphilis (6.8%) and Chlamydia (8.8%) infections and for selected behavioral risk characteristics. Results The original sample consisted of a large component of 249 people (83% of the sample) and 13 smaller components with 1 to 12 individuals. Generally, as long as all seeds were recruited from the large component of the original sample, the simulation samples simply recreated the large component. There were no significant differences between the large component and the entire original sample for the characteristics of interest. Altogether 99.2% of 360 simulation sample point estimates were within the confidence interval of the original prevalence values for the characteristics of interest. Conclusions When population characteristics are reflected in large network components that dominate the population, RDS and ISS may produce samples that have statistically non-different prevalence values, even though some isolated network components may be under-sampled and/or statistically significantly different from the main groups. This so-called “strudel effect” is discussed in the paper. PMID:24360650

  14. Stochastic wave-function unravelling of the generalized Lindblad equation

    NASA Astrophysics Data System (ADS)

    Semin, V.; Semina, I.; Petruccione, F.

    2017-12-01

    We investigate generalized non-Markovian stochastic Schrödinger equations (SSEs), driven by a multidimensional counting process and multidimensional Brownian motion introduced by A. Barchielli and C. Pellegrini [J. Math. Phys. 51, 112104 (2010), 10.1063/1.3514539]. We show that these SSEs can be translated in a nonlinear form, which can be efficiently simulated. The simulation is illustrated by the model of a two-level system in a structured bath, and the results of the simulations are compared with the exact solution of the generalized master equation.

  15. A post-processing method to simulate the generalized RF sheath boundary condition

    DOE Office of Scientific and Technical Information (OSTI.GOV)

    Myra, James R.; Kohno, Haruhiko

    For applications of ICRF power in fusion devices, control of RF sheath interactions is of great importance. A sheath boundary condition (SBC) was previously developed to provide an effective surface impedance for the interaction of the RF sheath with the waves. The SBC enables the surface power flux and rectified potential energy available for sputtering to be calculated. For legacy codes which cannot easily implement the SBC, or to speed convergence in codes which do implement it, we consider here an approximate method to simulate SBCs by post-processing results obtained using other, e.g. conducting wall, boundary conditions. The basic approximationmore » is that the modifications resulting from the generalized SBC are driven by a fixed incoming wave which could be either a fast wave or a slow wave. Finally, the method is illustrated in slab geometry and compared with exact numerical solutions; it is shown to work very well.« less

  16. A post-processing method to simulate the generalized RF sheath boundary condition

    DOE PAGES

    Myra, James R.; Kohno, Haruhiko

    2017-10-23

    For applications of ICRF power in fusion devices, control of RF sheath interactions is of great importance. A sheath boundary condition (SBC) was previously developed to provide an effective surface impedance for the interaction of the RF sheath with the waves. The SBC enables the surface power flux and rectified potential energy available for sputtering to be calculated. For legacy codes which cannot easily implement the SBC, or to speed convergence in codes which do implement it, we consider here an approximate method to simulate SBCs by post-processing results obtained using other, e.g. conducting wall, boundary conditions. The basic approximationmore » is that the modifications resulting from the generalized SBC are driven by a fixed incoming wave which could be either a fast wave or a slow wave. Finally, the method is illustrated in slab geometry and compared with exact numerical solutions; it is shown to work very well.« less

  17. Simulating planetary wave propagation to the upper atmosphere during stratospheric warming events at different mountain wave scenarios

    NASA Astrophysics Data System (ADS)

    Gavrilov, Nikolai M.; Koval, Andrey V.; Pogoreltsev, Alexander I.; Savenkova, Elena N.

    2018-04-01

    Parameterization schemes of atmospheric normal modes (NMs) and orographic gravity waves (OGWs) have been implemented into the mechanistic Middle and Upper Atmosphere Model (MUAM) simulating atmospheric general circulation. Based on the 12-members ensemble of runs with the MUAM, a composite of the stratospheric warming (SW) has been constructed using the UK Met Office data as the lower boundary conditions. The simulation results show that OGW amplitudes increase at altitudes above 30 km in the Northern Hemisphere after the SW event. At altitudes of about 50 km, OGWs have largest amplitudes over North American and European mountain systems before and during the composite SW, and over Himalayas after the SW. Simulations demonstrate substantial (up to 50-70%) variations of amplitudes of stationary planetary waves (PWs) during and after the SW in the mesosphere-lower thermosphere of the Northern Hemisphere. Westward travelling NMs have amplitude maxima not only in the Northern, but also in the Southern Hemisphere, where these modes have waveguides in the middle and upper atmosphere. Simulated variations of PW and NM amplitudes correspond to changes in the mean zonal wind, EP-fluxes and wave refractive index at different phases of the composite SW events. Inclusion of the parameterization of OGW effects leads to decreases in amplitudes (up to 15%) of almost all SPWs before and after the SW event and their increase (up to 40-60%) after the SW in the stratosphere and mesosphere at middle and high northern latitudes. It is suggested that observed changes in NM amplitudes in the Southern Hemisphere during SW could be caused by divergence of increased southward EP-flux. This EP-flux increases due to OGW drag before SW and extends into the Southern Hemisphere.

  18. Discrete Event Simulation Models for CT Examination Queuing in West China Hospital.

    PubMed

    Luo, Li; Liu, Hangjiang; Liao, Huchang; Tang, Shijun; Shi, Yingkang; Guo, Huili

    2016-01-01

    In CT examination, the emergency patients (EPs) have highest priorities in the queuing system and thus the general patients (GPs) have to wait for a long time. This leads to a low degree of satisfaction of the whole patients. The aim of this study is to improve the patients' satisfaction by designing new queuing strategies for CT examination. We divide the EPs into urgent type and emergency type and then design two queuing strategies: one is that the urgent patients (UPs) wedge into the GPs' queue with fixed interval (fixed priority model) and the other is that the patients have dynamic priorities for queuing (dynamic priority model). Based on the data from Radiology Information Database (RID) of West China Hospital (WCH), we develop some discrete event simulation models for CT examination according to the designed strategies. We compare the performance of different strategies on the basis of the simulation results. The strategy that patients have dynamic priorities for queuing makes the waiting time of GPs decrease by 13 minutes and the degree of satisfaction increase by 40.6%. We design a more reasonable CT examination queuing strategy to decrease patients' waiting time and increase their satisfaction degrees.

  19. Discrete Event Simulation Models for CT Examination Queuing in West China Hospital

    PubMed Central

    Luo, Li; Tang, Shijun; Shi, Yingkang; Guo, Huili

    2016-01-01

    In CT examination, the emergency patients (EPs) have highest priorities in the queuing system and thus the general patients (GPs) have to wait for a long time. This leads to a low degree of satisfaction of the whole patients. The aim of this study is to improve the patients' satisfaction by designing new queuing strategies for CT examination. We divide the EPs into urgent type and emergency type and then design two queuing strategies: one is that the urgent patients (UPs) wedge into the GPs' queue with fixed interval (fixed priority model) and the other is that the patients have dynamic priorities for queuing (dynamic priority model). Based on the data from Radiology Information Database (RID) of West China Hospital (WCH), we develop some discrete event simulation models for CT examination according to the designed strategies. We compare the performance of different strategies on the basis of the simulation results. The strategy that patients have dynamic priorities for queuing makes the waiting time of GPs decrease by 13 minutes and the degree of satisfaction increase by 40.6%. We design a more reasonable CT examination queuing strategy to decrease patients' waiting time and increase their satisfaction degrees. PMID:27547237

  20. Feasibility of performing high resolution cloud-resolving simulations of historic extreme events: The San Fruttuoso (Liguria, italy) case of 1915.

    NASA Astrophysics Data System (ADS)

    Parodi, Antonio; Boni, Giorgio; Ferraris, Luca; Gallus, William; Maugeri, Maurizio; Molini, Luca; Siccardi, Franco

    2017-04-01

    Recent studies show that highly localized and persistent back-building mesoscale convective systems represent one of the most dangerous flash-flood producing storms in the north-western Mediterranean area. Substantial warming of the Mediterranean Sea in recent decades raises concerns over possible increases in frequency or intensity of these types of events as increased atmospheric temperatures generally support increases in water vapor content. Analyses of available historical records do not provide a univocal answer, since these may be likely affected by a lack of detailed observations for older events. In the present study, 20th Century Reanalysis Project initial and boundary condition data in ensemble mode are used to address the feasibility of performing cloud-resolving simulations with 1 km horizontal grid spacing of a historic extreme event that occurred over Liguria (Italy): The San Fruttuoso case of 1915. The proposed approach focuses on the ensemble Weather Research and Forecasting (WRF) model runs, as they are the ones most likely to best simulate the event. It is found that these WRF runs generally do show wind and precipitation fields that are consistent with the occurrence of highly localized and persistent back-building mesoscale convective systems, although precipitation peak amounts are underestimated. Systematic small north-westward position errors with regard to the heaviest rain and strongest convergence areas imply that the Reanalysis members may not be adequately representing the amount of cool air over the Po Plain outflowing into the Liguria Sea through the Apennines gap. Regarding the role of historical data sources, this study shows that in addition to Reanalysis products, unconventional data, such as historical meteorological bulletins, newspapers and even photographs can be very valuable sources of knowledge in the reconstruction of past extreme events.

  1. Ocean Mixed Layer responses to intense meteorological events during HyMeX-SOP1 from a high-resolution ocean simulation

    NASA Astrophysics Data System (ADS)

    Lebeaupin Brossier, Cindy; Arsouze, Thomas; Béranger, Karine; Bouin, Marie-Noëlle; Bresson, Emilie; Ducrocq, Véronique; Giordani, Hervé; Nuret, Mathieu; Rainaud, Romain; Taupier-Letage, Isabelle

    2014-12-01

    The western Mediterranean Sea is a source of heat and humidity for the atmospheric low-levels in autumn. Large exchanges take place at the air-sea interface, especially during intense meteorological events, such as heavy precipitation and/or strong winds. The Ocean Mixed Layer (OML), which is quite thin at this time of year (∼ 20 m-depth), evolves rapidly under such intense fluxes. This study investigates the ocean responses under intense meteorological events that occurred during HyMeX SOP1 (5 September-6 November 2012). The OML conditions and tendencies are derived from a high-resolution ocean simulation using the sub-regional eddy-resolving NEMO-WMED36 model (1/36°-resolution), driven at the surface by hourly air-sea fluxes from the AROME-WMED forecasts (2.5 km-resolution). The high space-time resolution of the atmospheric forcing allows the highly variable surface fluxes, which induce rapid changes in the OML, to be well represented and linked to small-scale atmospheric processes. First, the simulation results are compared to ocean profiles from several platforms obtained during the campaign. Then, this study focuses on the short-term OML evolution during three events. In particular, we examine the OML cooling and mixing under strong wind events, potentially associated with upwelling, as well as the surface freshening under heavy precipitation events, producing low-salinity lenses. Tendencies demonstrate the major role of the surface forcing in the temperature and/or salinity anomaly formation. At the same time, mixing [restratification] rapidly occurs. As expected, the sign of this tendency term is very dependent on the local vertical stratification which varies at fine scale in the Mediterranean. It also controls [disables] the vertical propagation. In the Alboran Sea, the strong dynamics redistribute the OML anomalies, sometimes up to 7 days after their formation. Elsewhere, despite local amplitude modulations due to internal wave excitation by strong

  2. Off-equatorial current-driven instabilities ahead of approaching dipolarization fronts

    NASA Astrophysics Data System (ADS)

    Zhang, Xu; Angelopoulos, V.; Pritchett, P. L.; Liu, Jiang

    2017-05-01

    Recent kinetic simulations have revealed that electromagnetic instabilities near the ion gyrofrequency and slightly away from the equatorial plane can be driven by a current parallel to the magnetic field prior to the arrival of dipolarization fronts. Such instabilities are important because of their potential contribution to global electromagnetic energy conversion near dipolarization fronts. Of the several instabilities that may be consistent with such waves, the most notable are the current-driven electromagnetic ion cyclotron instability and the current-driven kink-like instability. To confirm the existence and characteristics of these instabilities, we used observations by two Time History of Events and Macroscale Interactions during Substorms satellites, one near the neutral sheet observing dipolarization fronts and the other at the boundary layer observing precursor waves and currents. We found that such instabilities with monochromatic signatures are rare, but one of the few cases was selected for further study. Two different instabilities, one at about 0.3 Hz and the other at a much lower frequency, 0.02 Hz, were seen in the data from the off-equatorial spacecraft. A parallel current attributed to an electron beam coexisted with the waves. Our instability analysis attributes the higher-frequency instability to a current-driven ion cyclotron instability and the lower frequency instability to a kink-like instability. The current-driven kink-like instability we observed is consistent with the instabilities observed in the simulation. We suggest that the currents needed to excite these low-frequency instabilities are so intense that the associated electron beams are easily thermalized and hence difficult to observe.

  3. Three-dimensional simulation of pseudopod-driven swimming of amoeboid cells

    NASA Astrophysics Data System (ADS)

    Campbell, Eric; Bagchi, Prosenjit

    2016-11-01

    Pseudopod-driven locomotion is common in eukaryotic cells, such as amoeba, neutrophils, and cancer cells. Pseudopods are protrusions of the cell body that grow, bifurcate, and retract. Due to the dynamic nature of pseudopods, the shape of a motile cell constantly changes. The actin-myosin protein dynamics is a likely mechanism for pseudopod growth. Existing theoretical models often focus on the acto-myosin dynamics, and not the whole cell shape dynamics. Here we present a full 3D simulation of pseudopod-driven motility by coupling a surface-bound reaction-diffusion (RD) model for the acto-myosin dynamics, a continuum model for the cell membrane deformation, and flow of the cytoplasmic and extracellular fluids. The whole cell is represented as a viscous fluid surrounded by a membrane. A finite-element method is used to solve the membrane deformation, and the RD model on the deforming membrane, while a finite-difference/spectral method is used to solve the flow fields inside and outside the cell. The fluid flow and cell deformation are coupled by the immersed-boundary method. The model predicts pseudopod growth, bifurcation, and retraction as observed for a swimming amoeba. The work provides insights on the role of membrane stiffness and cytoplasmic viscosity on amoeboid swimming. Funded by NSF CBET 1438255.

  4. Direct numerical simulation of incompressible acceleration-driven variable-density turbulence

    NASA Astrophysics Data System (ADS)

    Gat, Ilana; Matheou, Georgios; Chung, Daniel; Dimotakis, Paul

    2015-11-01

    Fully developed turbulence in variable-density flow driven by an externally imposed acceleration field, e.g., gravity, is fundamental in many applications, such as inertial confinement fusion, geophysics, and astrophysics. Aspects of this turbulence regime are poorly understood and are of interest to fluid modeling. We investigate incompressible acceleration-driven variable-density turbulence by a series of direct numerical simulations of high-density fluid in-between slabs of low-density fluid, in a triply-periodic domain. A pseudo-spectral numerical method with a Helmholtz-Hodge decomposition of the pressure field, which ensures mass conservation, is employed, as documented in Chung & Pullin (2010). A uniform dynamic viscosity and local Schmidt number of unity are assumed. This configuration encapsulates a combination of flow phenomena in a temporally evolving variable-density shear flow. Density ratios up to 10 and Reynolds numbers in the fully developed turbulent regime are investigated. The temporal evolution of the vertical velocity difference across the shear layer, shear-layer growth, mean density, and Reynolds number are discussed. Statistics of Lagrangian accelerations of fluid elements and of vorticity as a function of the density ratio are also presented. This material is based upon work supported by the AFOSR, the DOE, the NSF GRFP, and Caltech.

  5. Testing the Accuracy of Data-driven MHD Simulations of Active Region Evolution and Eruption

    NASA Astrophysics Data System (ADS)

    Leake, J. E.; Linton, M.; Schuck, P. W.

    2017-12-01

    Models for the evolution of the solar coronal magnetic field are vital for understanding solar activity, yet the best measurements of the magnetic field lie at the photosphere, necessitating the recent development of coronal models which are "data-driven" at the photosphere. Using magnetohydrodynamic simulations of active region formation and our recently created validation framework we investigate the source of errors in data-driven models that use surface measurements of the magnetic field, and derived MHD quantities, to model the coronal magnetic field. The primary sources of errors in these studies are the temporal and spatial resolution of the surface measurements. We will discuss the implications of theses studies for accurately modeling the build up and release of coronal magnetic energy based on photospheric magnetic field observations.

  6. Can discrete event simulation be of use in modelling major depression?

    PubMed

    Le Lay, Agathe; Despiegel, Nicolas; François, Clément; Duru, Gérard

    2006-12-05

    Depression is among the major contributors to worldwide disease burden and adequate modelling requires a framework designed to depict real world disease progression as well as its economic implications as closely as possible. In light of the specific characteristics associated with depression (multiple episodes at varying intervals, impact of disease history on course of illness, sociodemographic factors), our aim was to clarify to what extent "Discrete Event Simulation" (DES) models provide methodological benefits in depicting disease evolution. We conducted a comprehensive review of published Markov models in depression and identified potential limits to their methodology. A model based on DES principles was developed to investigate the benefits and drawbacks of this simulation method compared with Markov modelling techniques. The major drawback to Markov models is that they may not be suitable to tracking patients' disease history properly, unless the analyst defines multiple health states, which may lead to intractable situations. They are also too rigid to take into consideration multiple patient-specific sociodemographic characteristics in a single model. To do so would also require defining multiple health states which would render the analysis entirely too complex. We show that DES resolve these weaknesses and that its flexibility allow patients with differing attributes to move from one event to another in sequential order while simultaneously taking into account important risk factors such as age, gender, disease history and patients attitude towards treatment, together with any disease-related events (adverse events, suicide attempt etc.). DES modelling appears to be an accurate, flexible and comprehensive means of depicting disease progression compared with conventional simulation methodologies. Its use in analysing recurrent and chronic diseases appears particularly useful compared with Markov processes.

  7. A Physics-driven Neural Networks-based Simulation System (PhyNNeSS) for multimodal interactive virtual environments involving nonlinear deformable objects

    PubMed Central

    De, Suvranu; Deo, Dhannanjay; Sankaranarayanan, Ganesh; Arikatla, Venkata S.

    2012-01-01

    Background While an update rate of 30 Hz is considered adequate for real time graphics, a much higher update rate of about 1 kHz is necessary for haptics. Physics-based modeling of deformable objects, especially when large nonlinear deformations and complex nonlinear material properties are involved, at these very high rates is one of the most challenging tasks in the development of real time simulation systems. While some specialized solutions exist, there is no general solution for arbitrary nonlinearities. Methods In this work we present PhyNNeSS - a Physics-driven Neural Networks-based Simulation System - to address this long-standing technical challenge. The first step is an off-line pre-computation step in which a database is generated by applying carefully prescribed displacements to each node of the finite element models of the deformable objects. In the next step, the data is condensed into a set of coefficients describing neurons of a Radial Basis Function network (RBFN). During real-time computation, these neural networks are used to reconstruct the deformation fields as well as the interaction forces. Results We present realistic simulation examples from interactive surgical simulation with real time force feedback. As an example, we have developed a deformable human stomach model and a Penrose-drain model used in the Fundamentals of Laparoscopic Surgery (FLS) training tool box. Conclusions A unique computational modeling system has been developed that is capable of simulating the response of nonlinear deformable objects in real time. The method distinguishes itself from previous efforts in that a systematic physics-based pre-computational step allows training of neural networks which may be used in real time simulations. We show, through careful error analysis, that the scheme is scalable, with the accuracy being controlled by the number of neurons used in the simulation. PhyNNeSS has been integrated into SoFMIS (Software Framework for Multimodal

  8. Projected changes to rain-on-snow events over North America

    NASA Astrophysics Data System (ADS)

    Jeong, Dae Il; Sushama, Laxmi

    2016-04-01

    Rain-on-snow (ROS) events have significant impacts on cold region ecosystems and water-related natural hazards, and therefore it is very important to assess how this hydro-meteorological phenomenon will evolve in a changing climate. This study evaluates the changes in ROS characteristics (i.e., frequency, amounts, and runoff) for the future 2041-2070 period with respect to the current 1976-2005 period over North America using six simulations, based on two Canadian RCMs, driven by two driving GCMs for RCP4.5 and 8.5 emission pathways. Projected changes to extreme runoff caused by the changes of the ROS characteristics are also evaluated. All simulations suggest general increases in ROS days in late autumn, winter, and early spring periods for most Canadian regions and northwestern USA for the future period, due to an increase in rain days in a warmer climate. Increases in the future ROS amounts are projected mainly due to an increase in ROS days, although increases in precipitation intensity also contributes to the future increases. Future ROS runoff is expected to increase more than future ROS amounts during snowmelt months as ROS events usually enhance runoff, given the land state and asociated reduced soil infiltration rate and also due to the faster snowmelt rate occuring during these events. The simulations also show that ROS events usually lead to extreme runoff over most of Canada and north-western and -central USA in the January-May snowmelt months for the current period and these show no significant changes in the future climate. However, the future ROS to total runoff ratio will significantly decrease for western and eastern Canada as well as north-western USA for these months, due to an overall increase of the fraction of direct snowmelt and rainfall generated runoff in a warmer climate. These results indicate the difficulties of flood risk and water resource managements in the future, particularly in Canada and north-western and -central USA, requiring

  9. Discrete-Event Simulation Unmasks the Quantum Cheshire Cat

    NASA Astrophysics Data System (ADS)

    Michielsen, Kristel; Lippert, Thomas; Raedt, Hans De

    2017-05-01

    It is shown that discrete-event simulation accurately reproduces the experimental data of a single-neutron interferometry experiment [T. Denkmayr {\\sl et al.}, Nat. Commun. 5, 4492 (2014)] and provides a logically consistent, paradox-free, cause-and-effect explanation of the quantum Cheshire cat effect without invoking the notion that the neutron and its magnetic moment separate. Describing the experimental neutron data using weak-measurement theory is shown to be useless for unravelling the quantum Cheshire cat effect.

  10. Implementation of Argument-Driven Inquiry as an Instructional Model in a General Chemistry Laboratory Course

    ERIC Educational Resources Information Center

    Kadayifci, Hakki; Yalcin-Celik, Ayse

    2016-01-01

    This study examined the effectiveness of Argument-Driven Inquiry (ADI) as an instructional model in a general chemistry laboratory course. The study was conducted over the course of ten experimental sessions with 125 pre-service science teachers. The participants' level of reflective thinking about the ADI activities, changes in their science…

  11. General Purpose Heat Source Simulator

    NASA Technical Reports Server (NTRS)

    Emrich, William J., Jr.

    2008-01-01

    The General Purpose Heat Source (GPHS) project seeks to combine the development of an electrically heated, single GPHS module simulator with the evaluation of potential nuclear surface power systems. The simulator is designed to match the form, fit, and function of actual GPHS modules which normally generate heat through the radioactive decay of Pu238. The use of electrically heated modules rather than modules containing Pu238 facilitates the testing of the subsystems and systems without sacrificing the quantity and quality of the test data gathered. Current GPHS activities are centered on developing robust heater designs with sizes and weights which closely match those of actual Pu238 fueled GPHS blocks. Designs are being pursued which will allow operation up to 1100 C.

  12. Analysis of Intelligent Transportation Systems Using Model-Driven Simulations.

    PubMed

    Fernández-Isabel, Alberto; Fuentes-Fernández, Rubén

    2015-06-15

    Intelligent Transportation Systems (ITSs) integrate information, sensor, control, and communication technologies to provide transport related services. Their users range from everyday commuters to policy makers and urban planners. Given the complexity of these systems and their environment, their study in real settings is frequently unfeasible. Simulations help to address this problem, but present their own issues: there can be unintended mistakes in the transition from models to code; their platforms frequently bias modeling; and it is difficult to compare works that use different models and tools. In order to overcome these problems, this paper proposes a framework for a model-driven development of these simulations. It is based on a specific modeling language that supports the integrated specification of the multiple facets of an ITS: people, their vehicles, and the external environment; and a network of sensors and actuators conveniently arranged and distributed that operates over them. The framework works with a model editor to generate specifications compliant with that language, and a code generator to produce code from them using platform specifications. There are also guidelines to help researchers in the application of this infrastructure. A case study on advanced management of traffic lights with cameras illustrates its use.

  13. Analysis of Intelligent Transportation Systems Using Model-Driven Simulations

    PubMed Central

    Fernández-Isabel, Alberto; Fuentes-Fernández, Rubén

    2015-01-01

    Intelligent Transportation Systems (ITSs) integrate information, sensor, control, and communication technologies to provide transport related services. Their users range from everyday commuters to policy makers and urban planners. Given the complexity of these systems and their environment, their study in real settings is frequently unfeasible. Simulations help to address this problem, but present their own issues: there can be unintended mistakes in the transition from models to code; their platforms frequently bias modeling; and it is difficult to compare works that use different models and tools. In order to overcome these problems, this paper proposes a framework for a model-driven development of these simulations. It is based on a specific modeling language that supports the integrated specification of the multiple facets of an ITS: people, their vehicles, and the external environment; and a network of sensors and actuators conveniently arranged and distributed that operates over them. The framework works with a model editor to generate specifications compliant with that language, and a code generator to produce code from them using platform specifications. There are also guidelines to help researchers in the application of this infrastructure. A case study on advanced management of traffic lights with cameras illustrates its use. PMID:26083232

  14. 2 Gbit/s 0.5 μm complementary metal-oxide semiconductor optical transceiver with event-driven dynamic power-on capability

    NASA Astrophysics Data System (ADS)

    Wang, Xingle; Kiamilev, Fouad; Gui, Ping; Wang, Xiaoqing; Ekman, Jeremy; Zuo, Yongrong; Blankenberg, Jason; Haney, Michael

    2006-06-01

    A 2 Gb/s0.5 μm complementary metal-oxide semiconductor optical transceiver designed for board- or backplane level power-efficient interconnections is presented. The transceiver supports optical wake-on-link (OWL), an event-driven dynamic power-on technique. Depending on external events, the transceiver resides in either the active mode or the sleep mode and switches accordingly. The active-to-sleep transition shuts off the normal, gigabit link and turns on dedicated circuits to establish a low-power (~1.8 mW), low data rate (less than 100 Mbits/s) link. In contrast the normal, gigabit link consumes over 100 mW. Similarly the sleep-to-active transition shuts off the low-power link and turns on the normal, gigabit link. The low-power link, sharing the same optical channel with the normal, gigabit link, is used to achieve transmitter/receiver pair power-on synchronization and greatly reduces the power consumption of the transceiver. A free-space optical platform was built to evaluate the transceiver performance. The experiment successfully demonstrated the event-driven dynamic power-on operation. To our knowledge, this is the first time a dynamic power-on scheme has been implemented for optical interconnects. The areas of the circuits that implement the low-power link are approximately one-tenth of the areas of the gigabit link circuits.

  15. Simulation of the last sapropel event using high-regional oceanic model

    NASA Astrophysics Data System (ADS)

    Vadsaria, Tristan; Ramstein, Gilles; Li, Laurent; Dutay, jean-Claude

    2017-04-01

    Since decades, the simulation of sapropel events remains a challenge. These events, occurring periodically in the Mediterranean Sea produce a strong stratification of the water column and break intermediate and deep convection, thereby leading to a decrease in deep water oxygen, of which evidence are recorded in marine sediment cores. Data from Mediterranean sediments have thus helped to better understand the anoxia process, in particular for the last sapropel event, S1, lasting 3000 years about 10 kyrs ago. However the causal link between insolation changes and the African monsoon variations - thought to be the trigger of sapropel events -, and anoxia has still to be quantified. From a modelling point of view, a requisite for studying sapropel events is to capture seasonal winds that are instrumental in producing convection in the Med Sea. Recently, the development of high-resolution several models studies intend to fill this gap, building different scenarios (Grimm et al, 2015). Combining an atmospheric GCM (LMDZ4) and a high-resolution oceanic model (NEMOMED8, resolution of 1/8 degree) dedicated to the Med Sea, our first objective is to test whether monsoon precipitation triggered by insolation changes can increase the Nile run-off enough to stratify the East Mediterranean Sea. We notably show that a 15 mSv Nile runoff increase triggers a large decrease of convection in the whole Eastern Mediterranean Sea associated with strong anoxia in bottom waters.. Comparisons of our first experiments with δ18O and ɛ-Nd data will also be presented. Future work includes extending our simulations to investigate whether sapropel events can be maintained on longer time scales.

  16. Comparison of driven and simulated "free" stall flutter in a wind tunnel

    NASA Astrophysics Data System (ADS)

    Culler, Ethan; Farnsworth, John; Fagley, Casey; Seidel, Jurgen

    2016-11-01

    Stall flutter and dynamic stall have received a significant amount of attention over the years. To experimentally study this problem, the body undergoing stall flutter is typically driven at a characteristic, single frequency sinusoid with a prescribed pitching amplitude and mean angle of attack offset. This approach allows for testing with repeatable kinematics, however it effectively decouples the structural motion from the aerodynamic forcing. Recent results suggest that this driven approach could misrepresent the forcing observed in a "free" stall flutter scenario. Specifically, a dynamically pitched rigid NACA 0018 wing section was tested in the wind tunnel under two modes of operation: (1) Cyber-Physical where "free" stall flutter was physically simulated through a custom motor-control system modeling a torsional spring and (2) Direct Motor-Driven Dynamic Pitch at a single frequency sinusoid representative of the cyber-physical motion. The time-resolved pitch angle and moment were directly measured and compared for each case. It was found that small deviations in the pitch angle trajectory between these two operational cases generate significantly different aerodynamic pitching moments on the wing section, with the pitching moments nearly 180o out of phase in some cases. This work is supported by the Air Force Office of Scientific Research through the Flow Interactions and Control Program and by the National Defense Science and Engineering Graduate Fellowship Program.

  17. Numerical simulation and experimental study on farmland nitrogen loss to surface runoff in a raindrop driven process

    NASA Astrophysics Data System (ADS)

    Li, Jiayun; Tong, Juxiu; Xia, Chuanan; Hu, Bill X.; Zhu, Hao; Yang, Rui; Wei, Wenshuo

    2017-06-01

    It has been widely recognized that surface runoff from agricultural field is an important non-point pollution source, which however, the chemical transfer amount in the process is very difficult to be quantified in field since some variables and natural factors are hard to control, such as rainfall intensity, temperature, wind speeds and soil spatial heterogeneity, which may significantly affect the field experimental results. Therefore, a physically based nitrogen transport model was developed and tested with the so called semi-field experiments (i.e., artificial rainfall was used instead of natural rainfall, but other conditions were natural) in this paper. Our model integrated the raindrop driven process and diffusion effect with the simplified nitrogen chain reactions. In this model, chemicals in the soil surface layer, or the 'exchange layer', were transformed into the surface runoff layer due to raindrop impact. The raindrops also have a significant role on the diffusion process between the exchange layer and the underlying soil. The established mathematical model was solved numerically through the modified Hydrus-1d source code, and the model simulations agreed well with the experimental data. The modeling results indicate that the depth of the exchange layer and raindrop induced water transfer rate are two important parameters for the simulation results. Variation of the water transfer rate, er, can strongly influence the peak values of the NO-3-N and NH+4-N concentration breakthrough curves. The concentration of NO-3-N is more sensitive to the exchange layer depth, de, than NH+4-N. In general, the developed model well describes the nitrogen loss into surface runoff in a raindrop driven process. Since the raindrop splash erosion process may aggravate the loss of chemical fertilizer, choosing an appropriate fertilization time and application method is very important to prevent the pollution.

  18. Preparation of severely curved simulated root canals using engine-driven rotary and conventional hand instruments.

    PubMed

    Szep, S; Gerhardt, T; Leitzbach, C; Lüder, W; Heidemann, D

    2001-03-01

    This in vitro study evaluated the efficacy and safety of six different nickel-titanium engine-driven instruments used with a torque-controlled engine device and nickel-titanium hand and stainless steel hand instruments in preparation of curved canals. A total of 80 curved (36 degrees) simulated root canals were prepared. Images before and after were superimposed, and instrumentation areas were observed. Time of instrumentation, instrument failure, change in working length and weight loss were also recorded. Results show that stainless steel hand instruments cause significantly less transportation towards the inner wall of the canal than do nickel-titanium hand instruments. No instrument fracture occurred with hand instruments, but 30-60% breakage of instruments was recorded during instrumentation with the engine-driven devices. The working length was maintained by all types of instruments. Newly developed nickel-titanium rotary files were not able to prevent straightening of the severely curved canals when a torque-controlled engine-driven device was used.

  19. Driven Metadynamics: Reconstructing Equilibrium Free Energies from Driven Adaptive-Bias Simulations

    PubMed Central

    2013-01-01

    We present a novel free-energy calculation method that constructively integrates two distinct classes of nonequilibrium sampling techniques, namely, driven (e.g., steered molecular dynamics) and adaptive-bias (e.g., metadynamics) methods. By employing nonequilibrium work relations, we design a biasing protocol with an explicitly time- and history-dependent bias that uses on-the-fly work measurements to gradually flatten the free-energy surface. The asymptotic convergence of the method is discussed, and several relations are derived for free-energy reconstruction and error estimation. Isomerization reaction of an atomistic polyproline peptide model is used to numerically illustrate the superior efficiency and faster convergence of the method compared with its adaptive-bias and driven components in isolation. PMID:23795244

  20. Conceptual Modeling of a Quantum Key Distribution Simulation Framework Using the Discrete Event System Specification

    DTIC Science & Technology

    2014-09-18

    and full/scale experimental verifications towards ground/ satellite quantum key distribution0 Oat Qhotonics 4235>9+7,=5;9!អ \\58^ Zin K. Dao Z. Miu T...Conceptual Modeling of a Quantum Key Distribution Simulation Framework Using the Discrete Event System Specification DISSERTATION Jeffrey D. Morris... QUANTUM KEY DISTRIBUTION SIMULATION FRAMEWORK USING THE DISCRETE EVENT SYSTEM SPECIFICATION DISSERTATION Presented to the Faculty Department of Systems

  1. Quantitative Simulation of QARBM Challenge Events During Radiation Belt Enhancements

    NASA Astrophysics Data System (ADS)

    Li, W.; Ma, Q.; Thorne, R. M.; Bortnik, J.; Chu, X.

    2017-12-01

    Various physical processes are known to affect energetic electron dynamics in the Earth's radiation belts, but their quantitative effects at different times and locations in space need further investigation. This presentation focuses on discussing the quantitative roles of various physical processes that affect Earth's radiation belt electron dynamics during radiation belt enhancement challenge events (storm-time vs. non-storm-time) selected by the GEM Quantitative Assessment of Radiation Belt Modeling (QARBM) focus group. We construct realistic global distributions of whistler-mode chorus waves, adopt various versions of radial diffusion models (statistical and event-specific), and use the global evolution of other potentially important plasma waves including plasmaspheric hiss, magnetosonic waves, and electromagnetic ion cyclotron waves from all available multi-satellite measurements. These state-of-the-art wave properties and distributions on a global scale are used to calculate diffusion coefficients, that are then adopted as inputs to simulate the dynamical electron evolution using a 3D diffusion simulation during the storm-time and the non-storm-time acceleration events respectively. We explore the similarities and differences in the dominant physical processes that cause radiation belt electron dynamics during the storm-time and non-storm-time acceleration events. The quantitative role of each physical process is determined by comparing against the Van Allen Probes electron observations at different energies, pitch angles, and L-MLT regions. This quantitative comparison further indicates instances when quasilinear theory is sufficient to explain the observed electron dynamics or when nonlinear interaction is required to reproduce the energetic electron evolution observed by the Van Allen Probes.

  2. Intermittency in flux driven kinetic simulations of trapped ion turbulence

    NASA Astrophysics Data System (ADS)

    Darmet, G.; Ghendrih, Ph.; Sarazin, Y.; Garbet, X.; Grandgirard, V.

    2008-02-01

    Flux driven kinetic transport is analysed for deeply trapped ion turbulence with the code GYSELA. The main observation is the existence of a steady state situation with respect to the statistics, in particular the balance between the injected energy and the time averaged energy flowing out through the outer edge boundary layer. The temperature is characterised by a very bursty behaviour with a skewed PDF. Superimposed to these short time scale fluctuations, one finds a regime with a strong increase of the zonal flows and a quenching of the turbulent energy. During this phase of such a predator-prey cycle, the core temperature rapidly increases while the edge temperature gradually decreases. The end of this reduced transport regime is governed by the onset of turbulence that governs large relaxation events, and a strong modification of the zonal flow pattern.

  3. Where Tori Fear to Tread: Hypermassive Neutron Star Remnants and Absolute Event Horizons or Topics in Computational General Relativity

    NASA Astrophysics Data System (ADS)

    Kaplan, Jeffrey Daniel

    2014-01-01

    Computational general relativity is a field of study which has reached maturity only within the last decade. This thesis details several studies that elucidate phenomena related to the coalescence of compact object binaries. Chapters 2 and 3 recounts work towards developing new analytical tools for visualizing and reasoning about dynamics in strongly curved spacetimes. In both studies, the results employ analogies with the classical theory of electricity and magnetism, first (Ch. 2) in the post-Newtonian approximation to general relativity and then (Ch. 3) in full general relativity though in the absence of matter sources. In Chapter 4, we examine the topological structure of absolute event horizons during binary black hole merger simulations conducted with the SpEC code. Chapter 6 reports on the progress of the SpEC code in simulating the coalescence of neutron star-neutron star binaries, while Chapter 7 tests the effects of various numerical gauge conditions on the robustness of black hole formation from stellar collapse in SpEC. In Chapter 5, we examine the nature of pseudospectral expansions of non-smooth functions motivated by the need to simulate the stellar surface in Chapters 6 and 7. In Chapter 8, we study how thermal effects in the nuclear equation of state effect the equilibria and stability of hypermassive neutron stars. Chapter 9 presents supplements to the work in Chapter 8, including an examination of the stability question raised in Chapter 8 in greater mathematical detail.

  4. Can discrete event simulation be of use in modelling major depression?

    PubMed Central

    Le Lay, Agathe; Despiegel, Nicolas; François, Clément; Duru, Gérard

    2006-01-01

    Background Depression is among the major contributors to worldwide disease burden and adequate modelling requires a framework designed to depict real world disease progression as well as its economic implications as closely as possible. Objectives In light of the specific characteristics associated with depression (multiple episodes at varying intervals, impact of disease history on course of illness, sociodemographic factors), our aim was to clarify to what extent "Discrete Event Simulation" (DES) models provide methodological benefits in depicting disease evolution. Methods We conducted a comprehensive review of published Markov models in depression and identified potential limits to their methodology. A model based on DES principles was developed to investigate the benefits and drawbacks of this simulation method compared with Markov modelling techniques. Results The major drawback to Markov models is that they may not be suitable to tracking patients' disease history properly, unless the analyst defines multiple health states, which may lead to intractable situations. They are also too rigid to take into consideration multiple patient-specific sociodemographic characteristics in a single model. To do so would also require defining multiple health states which would render the analysis entirely too complex. We show that DES resolve these weaknesses and that its flexibility allow patients with differing attributes to move from one event to another in sequential order while simultaneously taking into account important risk factors such as age, gender, disease history and patients attitude towards treatment, together with any disease-related events (adverse events, suicide attempt etc.). Conclusion DES modelling appears to be an accurate, flexible and comprehensive means of depicting disease progression compared with conventional simulation methodologies. Its use in analysing recurrent and chronic diseases appears particularly useful compared with Markov processes

  5. Consistent data-driven computational mechanics

    NASA Astrophysics Data System (ADS)

    González, D.; Chinesta, F.; Cueto, E.

    2018-05-01

    We present a novel method, within the realm of data-driven computational mechanics, to obtain reliable and thermodynamically sound simulation from experimental data. We thus avoid the need to fit any phenomenological model in the construction of the simulation model. This kind of techniques opens unprecedented possibilities in the framework of data-driven application systems and, particularly, in the paradigm of industry 4.0.

  6. Is the "sterile cockpit" concept applicable to cardiovascular surgery critical intervals or critical events? The impact of protocol-driven communication during cardiopulmonary bypass.

    PubMed

    Wadhera, Rishi K; Parker, Sarah Henrickson; Burkhart, Harold M; Greason, Kevin L; Neal, James R; Levenick, Katherine M; Wiegmann, Douglas A; Sundt, Thoralf M

    2010-02-01

    There is general enthusiasm for applying strategies from aviation directly to medical care; the application of the "sterile cockpit" rule to surgery has accordingly been suggested. An implicit prerequisite to the evidence-based transfer of such a concept to the clinical domain, however, is definition of periods of high mental workload analogous to takeoff and landing. We measured cognitive demands among operating room staff, mapped critical events, and evaluated protocol-driven communication. With the National Aeronautics and Space Administration Task Load Index and semistructured focus groups, we identified common critical stages of cardiac surgical cases. Intraoperative communication was assessed before (n = 18) and after (n = 16) introduction of a structured communication protocol. Cognitive workload measures demonstrated high temporal diversity among caregivers in various roles. Eight critical events during cardiopulmonary bypass were then defined. A structured, unambiguous verbal communication protocol for these events was then implemented. Observations of 18 cases before implementation including 29.6 hours of cardiopulmonary bypass with 632 total communication exchanges (average 35.1 exchanges/case) were compared with observations of 16 cases after implementation including 23.9 hours of cardiopulmonary bypass with 748 exchanges (average 46.8 exchanges/case, P = .06). Frequency of communication breakdowns per case decreased significantly after implementation (11.5 vs 7.3 breakdowns/case, P = .008). Because of wide variations is cognitive workload among caregivers, effective communication can be structured around critical events rather than defined intervals analogous to the sterile cockpit, with reduction in communication breakdowns. 2010 The American Association for Thoracic Surgery. Published by Mosby, Inc. All rights reserved.

  7. EMERGENCY BRAKING IN ADULTS VERSUS NOVICE TEEN DRIVERS: RESPONSE TO SIMULATED SUDDEN DRIVING EVENTS.

    PubMed

    Loeb, Helen S; Kandadai, Venk; McDonald, Catherine C; Winston, Flaura K

    Motor vehicle crashes remain the leading cause of death in teens in the United States. Newly licensed drivers are the group most at risk for crashes. Their driving skills are very new, still very often untested, so that their ability to properly react in an emergency situation remains a research question. Since it is impossible to expose human subjects to critical life threatening driving scenarios, researchers have been increasingly using driving simulators to assess driving skills. This paper summarizes the results of a driving scenario in a study comparing the driving performance of novice teen drivers (n=21) 16-17 year olds with 90 days of provisional licensure with that of experienced adult drivers (n=17) 25-50 year olds with at least 5 years of PA licensure, at least 100 miles driven per week and no self-reported collisions in the previous 3 years. As part of a 30 to 35 simulated drive that encompassed the most common scenarios that result in serious crashes, participants were exposed to a sudden car event. As the participant drove on a suburban road, a car surged from a driveway hidden by a fence on the right side of the road. To avoid the crash, participants must hard brake, exhibiting dynamic control over both attentional and motor resources. The results showed strong differences between the experienced adult and novice teen drivers in the brake pressure applied. When placed in the same situation, the novice teens decelerated on average 50% less than the experienced adults (p<0.01).

  8. Global simulation study for the time sequence of events leading to the substorm onset

    NASA Astrophysics Data System (ADS)

    Tanaka, T.; Ebihara, Y.; Watanabe, M.; Den, M.; Fujita, S.; Kikuchi, T.; Hashimoto, K. K.; Kataoka, R.

    2017-06-01

    We have developed a global simulation code which gives numerical solutions having an extremely high resolution. The substorm solution obtained from this simulation code reproduces the precise features of the substorm onset in the ionosphere. It can reproduce the onset that starts from the equatorward side of the quiet arc, two step development of the onset, and the westward traveling surge (WTS) that starts 2 min after the initial brightening. Then, we investigated the counter structures in the magnetosphere that correspond to each event in the ionosphere. The structure in the magnetosphere promoting the onset is the near-Earth dynamo in the inner magnetospheric region away from the equatorial plane. The near-Earth dynamo is driven by the field-aligned pressure increase due to the parallel flow associated with the squeezing, combined with equatorward field-perpendicular flow induced by the near-Earth neutral line (NENL). The dipolarization front is launched from the NENL associated with the convection transient from the growth phase to the expansion phase, but neither the launch nor the arrival of the dipolarization front coincides with the onset timing. The arrival of flow to the equatorial plane of the inner magnetosphere occurs 2 min after the onset, when the WTS starts to develop toward the west. The expansion phase is further developed by this flow. Looking at the present result that the onset sequence induced by the near-Earth dynamo reproduces the details of observation quite well, we cannot avoid to conclude that the current wedge is a misleading concept.

  9. EMERGENCY BRAKING IN ADULTS VERSUS NOVICE TEEN DRIVERS: RESPONSE TO SIMULATED SUDDEN DRIVING EVENTS

    PubMed Central

    Kandadai, Venk; McDonald, Catherine C.; Winston, Flaura K.

    2015-01-01

    Motor vehicle crashes remain the leading cause of death in teens in the United States. Newly licensed drivers are the group most at risk for crashes. Their driving skills are very new, still very often untested, so that their ability to properly react in an emergency situation remains a research question. Since it is impossible to expose human subjects to critical life threatening driving scenarios, researchers have been increasingly using driving simulators to assess driving skills. This paper summarizes the results of a driving scenario in a study comparing the driving performance of novice teen drivers (n=21) 16–17 year olds with 90 days of provisional licensure with that of experienced adult drivers (n=17) 25–50 year olds with at least 5 years of PA licensure, at least 100 miles driven per week and no self-reported collisions in the previous 3 years. As part of a 30 to 35 simulated drive that encompassed the most common scenarios that result in serious crashes, participants were exposed to a sudden car event. As the participant drove on a suburban road, a car surged from a driveway hidden by a fence on the right side of the road. To avoid the crash, participants must hard brake, exhibiting dynamic control over both attentional and motor resources. The results showed strong differences between the experienced adult and novice teen drivers in the brake pressure applied. When placed in the same situation, the novice teens decelerated on average 50% less than the experienced adults (p<0.01). PMID:26709330

  10. General Relativistic MHD Simulations of Jet Formation

    NASA Technical Reports Server (NTRS)

    Mizuno, Y.; Nishikawa, K.-I.; Hardee, P.; Koide, S.; Fishman, G. J.

    2005-01-01

    We have performed 3-dimensional general relativistic magnetohydrodynamic (GRMHD) simulations of jet formation from an accretion disk with/without initial perturbation around a rotating black hole. We input a sinusoidal perturbation (m = 5 mode) in the rotation velocity of the accretion disk. The simulation results show the formation of a relativistic jet from the accretion disk. Although the initial perturbation becomes weakened by the coupling among different modes, it survives and triggers lower modes. As a result, complex non-axisymmetric density structure develops in the disk and the jet. Newtonian MHD simulations of jet formation with a non-axisymmetric mode show the growth of the m = 2 mode but GRMHD simulations cannot see the clear growth of the m = 2 mode.

  11. Simulability of observables in general probabilistic theories

    NASA Astrophysics Data System (ADS)

    Filippov, Sergey N.; Heinosaari, Teiko; Leppäjärvi, Leevi

    2018-06-01

    The existence of incompatibility is one of the most fundamental features of quantum theory and can be found at the core of many of the theory's distinguishing features, such as Bell inequality violations and the no-broadcasting theorem. A scheme for obtaining new observables from existing ones via classical operations, the so-called simulation of observables, has led to an extension of the notion of compatibility for measurements. We consider the simulation of observables within the operational framework of general probabilistic theories and introduce the concept of simulation irreducibility. While a simulation irreducible observable can only be simulated by itself, we show that any observable can be simulated by simulation irreducible observables, which in the quantum case correspond to extreme rank-1 positive-operator-valued measures. We also consider cases where the set of simulators is restricted in one of two ways: in terms of either the number of simulating observables or their number of outcomes. The former is seen to be closely connected to compatibility and k compatibility, whereas the latter leads to a partial characterization for dichotomic observables. In addition to the quantum case, we further demonstrate these concepts in state spaces described by regular polygons.

  12. GLOBAL HIGH-RESOLUTION N-BODY SIMULATION OF PLANET FORMATION. I. PLANETESIMAL-DRIVEN MIGRATION

    DOE Office of Scientific and Technical Information (OSTI.GOV)

    Kominami, J. D.; Daisaka, H.; Makino, J.

    2016-03-01

    We investigated whether outward planetesimal-driven migration (PDM) takes place or not in simulations when the self-gravity of planetesimals is included. We performed N-body simulations of planetesimal disks with a large width (0.7–4 au) that ranges over the ice line. The simulations consisted of two stages. The first-stage simulations were carried out to see the runaway growth phase using the planetesimals of initially the same mass. The runaway growth took place both at the inner edge of the disk and at the region just outside the ice line. This result was utilized for the initial setup of the second-stage simulations, in which themore » runaway bodies just outside the ice line were replaced by the protoplanets with about the isolation mass. In the second-stage simulations, the outward migration of the protoplanet was followed by the stopping of the migration due to the increase of the random velocity of the planetesimals. Owing to this increase of random velocities, one of the PDM criteria derived in Minton and Levison was broken. In the current simulations, the effect of the gas disk is not considered. It is likely that the gas disk plays an important role in PDM, and we plan to study its effect in future papers.« less

  13. A fully coupled method for massively parallel simulation of hydraulically driven fractures in 3-dimensions: FULLY COUPLED PARALLEL SIMULATION OF HYDRAULIC FRACTURES IN 3-D

    DOE PAGES

    Settgast, Randolph R.; Fu, Pengcheng; Walsh, Stuart D. C.; ...

    2016-09-18

    This study describes a fully coupled finite element/finite volume approach for simulating field-scale hydraulically driven fractures in three dimensions, using massively parallel computing platforms. The proposed method is capable of capturing realistic representations of local heterogeneities, layering and natural fracture networks in a reservoir. A detailed description of the numerical implementation is provided, along with numerical studies comparing the model with both analytical solutions and experimental results. The results demonstrate the effectiveness of the proposed method for modeling large-scale problems involving hydraulically driven fractures in three dimensions.

  14. A fully coupled method for massively parallel simulation of hydraulically driven fractures in 3-dimensions: FULLY COUPLED PARALLEL SIMULATION OF HYDRAULIC FRACTURES IN 3-D

    DOE Office of Scientific and Technical Information (OSTI.GOV)

    Settgast, Randolph R.; Fu, Pengcheng; Walsh, Stuart D. C.

    This study describes a fully coupled finite element/finite volume approach for simulating field-scale hydraulically driven fractures in three dimensions, using massively parallel computing platforms. The proposed method is capable of capturing realistic representations of local heterogeneities, layering and natural fracture networks in a reservoir. A detailed description of the numerical implementation is provided, along with numerical studies comparing the model with both analytical solutions and experimental results. The results demonstrate the effectiveness of the proposed method for modeling large-scale problems involving hydraulically driven fractures in three dimensions.

  15. DeMO: An Ontology for Discrete-event Modeling and Simulation.

    PubMed

    Silver, Gregory A; Miller, John A; Hybinette, Maria; Baramidze, Gregory; York, William S

    2011-09-01

    Several fields have created ontologies for their subdomains. For example, the biological sciences have developed extensive ontologies such as the Gene Ontology, which is considered a great success. Ontologies could provide similar advantages to the Modeling and Simulation community. They provide a way to establish common vocabularies and capture knowledge about a particular domain with community-wide agreement. Ontologies can support significantly improved (semantic) search and browsing, integration of heterogeneous information sources, and improved knowledge discovery capabilities. This paper discusses the design and development of an ontology for Modeling and Simulation called the Discrete-event Modeling Ontology (DeMO), and it presents prototype applications that demonstrate various uses and benefits that such an ontology may provide to the Modeling and Simulation community.

  16. DeMO: An Ontology for Discrete-event Modeling and Simulation

    PubMed Central

    Silver, Gregory A; Miller, John A; Hybinette, Maria; Baramidze, Gregory; York, William S

    2011-01-01

    Several fields have created ontologies for their subdomains. For example, the biological sciences have developed extensive ontologies such as the Gene Ontology, which is considered a great success. Ontologies could provide similar advantages to the Modeling and Simulation community. They provide a way to establish common vocabularies and capture knowledge about a particular domain with community-wide agreement. Ontologies can support significantly improved (semantic) search and browsing, integration of heterogeneous information sources, and improved knowledge discovery capabilities. This paper discusses the design and development of an ontology for Modeling and Simulation called the Discrete-event Modeling Ontology (DeMO), and it presents prototype applications that demonstrate various uses and benefits that such an ontology may provide to the Modeling and Simulation community. PMID:22919114

  17. Evaluation of the HadGEM3-A simulations in view of detection and attribution of human influence on extreme events in Europe

    NASA Astrophysics Data System (ADS)

    Vautard, Robert; Christidis, Nikolaos; Ciavarella, Andrew; Alvarez-Castro, Carmen; Bellprat, Omar; Christiansen, Bo; Colfescu, Ioana; Cowan, Tim; Doblas-Reyes, Francisco; Eden, Jonathan; Hauser, Mathias; Hegerl, Gabriele; Hempelmann, Nils; Klehmet, Katharina; Lott, Fraser; Nangini, Cathy; Orth, René; Radanovics, Sabine; Seneviratne, Sonia I.; van Oldenborgh, Geert Jan; Stott, Peter; Tett, Simon; Wilcox, Laura; Yiou, Pascal

    2018-04-01

    A detailed analysis is carried out to assess the HadGEM3-A global atmospheric model skill in simulating extreme temperatures, precipitation and storm surges in Europe in the view of their attribution to human influence. The analysis is performed based on an ensemble of 15 atmospheric simulations forced with observed sea surface temperature of the 54 year period 1960-2013. These simulations, together with dual simulations without human influence in the forcing, are intended to be used in weather and climate event attribution. The analysis investigates the main processes leading to extreme events, including atmospheric circulation patterns, their links with temperature extremes, land-atmosphere and troposphere-stratosphere interactions. It also compares observed and simulated variability, trends and generalized extreme value theory parameters for temperature and precipitation. One of the most striking findings is the ability of the model to capture North-Atlantic atmospheric weather regimes as obtained from a cluster analysis of sea level pressure fields. The model also reproduces the main observed weather patterns responsible for temperature and precipitation extreme events. However, biases are found in many physical processes. Slightly excessive drying may be the cause of an overestimated summer interannual variability and too intense heat waves, especially in central/northern Europe. However, this does not seem to hinder proper simulation of summer temperature trends. Cold extremes appear well simulated, as well as the underlying blocking frequency and stratosphere-troposphere interactions. Extreme precipitation amounts are overestimated and too variable. The atmospheric conditions leading to storm surges were also examined in the Baltics region. There, simulated weather conditions appear not to be leading to strong enough storm surges, but winds were found in very good agreement with reanalyses. The performance in reproducing atmospheric weather patterns

  18. Effects of climate events driven hydrodynamics on dissolved oxygen in a subtropical deep reservoir in Taiwan.

    PubMed

    Fan, Cheng-Wei; Kao, Shuh-Ji

    2008-04-15

    The seasonal concentrations of dissolved oxygen in a subtropical deep reservoir were studied over a period of one year. The study site was the Feitsui Reservoir in Taiwan. It is a dam-constructed reservoir with a surface area of 10.24 km(2) and a mean depth of 39.6 m, with a maximum depth of 113.5 m near the dam. It was found that certain weather and climate events, such as typhoons in summer and autumn, as well as cold fronts in winter, can deliver oxygen-rich water, and consequently have strong impacts on the dissolved oxygen level. The typhoon turbidity currents and winter density currents played important roles in supplying oxygen to the middle and bottom water, respectively. The whole process can be understood by the hydrodynamics driven by weather and climate events. This work provides the primary results of dissolved oxygen in a subtropical deep reservoir, and the knowledge is useful in understanding water quality in subtropical regions.

  19. General Aviation Cockpit Weather Information System Simulation Studies

    NASA Technical Reports Server (NTRS)

    McAdaragh, Ray; Novacek, Paul

    2003-01-01

    This viewgraph presentation provides information on two experiments on the effectiveness of a cockpit weather information system on a simulated general aviation flight. The presentation covers the simulation hardware configuration, the display device screen layout, a mission scenario, conclusions, and recommendations. The second experiment, with its own scenario and conclusions, is a follow-on experiment.

  20. Attribution of Extreme Rainfall Events in the South of France Using EURO-CORDEX Simulations

    NASA Astrophysics Data System (ADS)

    Luu, L. N.; Vautard, R.; Yiou, P.

    2017-12-01

    The Mediterranean region regularly undergoes episodes of intense precipitation in the fall season that exceed 300mm a day. This study focuses on the role of climate change on the dynamics of the events that occur in the South of France. We used an ensemble of 10 EURO-CORDEX model simulations with two horizontal resolutions (EUR-11: 0.11° and EUR-44: 0.44°) for the attribution of extreme rainfall in the fall in the Cevennes mountain range (South of France). The biases of the simulations were corrected with simple scaling adjustment and a quantile correction (CDFt). This produces five datasets including EUR-44 and EUR-11 with and without scaling adjustment and CDFt-EUR-11, on which we test the impact of resolution and bias correction on the extremes. Those datasets, after pooling all of models together, are fitted by a stationary Generalized Extreme Value distribution for several periods to estimate a climate change signal in the tail of distribution of extreme rainfall in the Cévenne region. Those changes are then interpreted by a scaling model that links extreme rainfall with mean and maximum daily temperature. The results show that higher-resolution simulations with bias adjustment provide a robust and confident increase of intensity and likelihood of occurrence of autumn extreme rainfall in the area in current climate in comparison with historical climate. The probability (exceedance probability) of 1-in-1000-year event in historical climate may increase by a factor of 1.8 under current climate with a confident interval of 0.4 to 5.3 following the CDFt bias-adjusted EUR-11. The change of magnitude appears to follow the Clausius-Clapeyron relation that indicates a 7% increase in rainfall per 1oC increase in temperature.

  1. Numerical simulations of an advection fog event over Shanghai Pudong International Airport with the WRF model

    NASA Astrophysics Data System (ADS)

    Lin, Caiyan; Zhang, Zhongfeng; Pu, Zhaoxia; Wang, Fengyun

    2017-10-01

    A series of numerical simulations is conducted to understand the formation, evolution, and dissipation of an advection fog event over Shanghai Pudong International Airport (ZSPD) with the Weather Research and Forecasting (WRF) model. Using the current operational settings at the Meteorological Center of East China Air Traffic Management Bureau, the WRF model successfully predicts the fog event at ZSPD. Additional numerical experiments are performed to examine the physical processes associated with the fog event. The results indicate that prediction of this particular fog event is sensitive to microphysical schemes for the time of fog dissipation but not for the time of fog onset. The simulated timing of the arrival and dissipation of the fog, as well as the cloud distribution, is substantially sensitive to the planetary boundary layer and radiation (both longwave and shortwave) processes. Moreover, varying forecast lead times also produces different simulation results for the fog event regarding its onset and duration, suggesting a trade-off between more accurate initial conditions and a proper forecast lead time that allows model physical processes to spin up adequately during the fog simulation. The overall outcomes from this study imply that the complexity of physical processes and their interactions within the WRF model during fog evolution and dissipation is a key area of future research.

  2. Assessing respondent-driven sampling.

    PubMed

    Goel, Sharad; Salganik, Matthew J

    2010-04-13

    Respondent-driven sampling (RDS) is a network-based technique for estimating traits in hard-to-reach populations, for example, the prevalence of HIV among drug injectors. In recent years RDS has been used in more than 120 studies in more than 20 countries and by leading public health organizations, including the Centers for Disease Control and Prevention in the United States. Despite the widespread use and growing popularity of RDS, there has been little empirical validation of the methodology. Here we investigate the performance of RDS by simulating sampling from 85 known, network populations. Across a variety of traits we find that RDS is substantially less accurate than generally acknowledged and that reported RDS confidence intervals are misleadingly narrow. Moreover, because we model a best-case scenario in which the theoretical RDS sampling assumptions hold exactly, it is unlikely that RDS performs any better in practice than in our simulations. Notably, the poor performance of RDS is driven not by the bias but by the high variance of estimates, a possibility that had been largely overlooked in the RDS literature. Given the consistency of our results across networks and our generous sampling conditions, we conclude that RDS as currently practiced may not be suitable for key aspects of public health surveillance where it is now extensively applied.

  3. Assessing respondent-driven sampling

    PubMed Central

    Goel, Sharad; Salganik, Matthew J.

    2010-01-01

    Respondent-driven sampling (RDS) is a network-based technique for estimating traits in hard-to-reach populations, for example, the prevalence of HIV among drug injectors. In recent years RDS has been used in more than 120 studies in more than 20 countries and by leading public health organizations, including the Centers for Disease Control and Prevention in the United States. Despite the widespread use and growing popularity of RDS, there has been little empirical validation of the methodology. Here we investigate the performance of RDS by simulating sampling from 85 known, network populations. Across a variety of traits we find that RDS is substantially less accurate than generally acknowledged and that reported RDS confidence intervals are misleadingly narrow. Moreover, because we model a best-case scenario in which the theoretical RDS sampling assumptions hold exactly, it is unlikely that RDS performs any better in practice than in our simulations. Notably, the poor performance of RDS is driven not by the bias but by the high variance of estimates, a possibility that had been largely overlooked in the RDS literature. Given the consistency of our results across networks and our generous sampling conditions, we conclude that RDS as currently practiced may not be suitable for key aspects of public health surveillance where it is now extensively applied. PMID:20351258

  4. Quality Improvement With Discrete Event Simulation: A Primer for Radiologists.

    PubMed

    Booker, Michael T; O'Connell, Ryan J; Desai, Bhushan; Duddalwar, Vinay A

    2016-04-01

    The application of simulation software in health care has transformed quality and process improvement. Specifically, software based on discrete-event simulation (DES) has shown the ability to improve radiology workflows and systems. Nevertheless, despite the successful application of DES in the medical literature, the power and value of simulation remains underutilized. For this reason, the basics of DES modeling are introduced, with specific attention to medical imaging. In an effort to provide readers with the tools necessary to begin their own DES analyses, the practical steps of choosing a software package and building a basic radiology model are discussed. In addition, three radiology system examples are presented, with accompanying DES models that assist in analysis and decision making. Through these simulations, we provide readers with an understanding of the theory, requirements, and benefits of implementing DES in their own radiology practices. Copyright © 2016 American College of Radiology. All rights reserved.

  5. Simulations of laser-driven ion acceleration from a thin CH target

    NASA Astrophysics Data System (ADS)

    Park, Jaehong; Bulanov, Stepan; Ji, Qing; Steinke, Sven; Treffert, Franziska; Vay, Jean-Luc; Schenkel, Thomas; Esarey, Eric; Leemans, Wim; Vincenti, Henri

    2017-10-01

    2D and 3D computer simulations of laser driven ion acceleration from a thin CH foil using code WARP were performed. As the foil thickness varies from a few nm to μm, the simulations confirm that the acceleration mechanism transitions from the RPA (radiation pressure acceleration) to the TNSA (target normal sheath acceleration). In the TNSA regime, with the CH target thickness of 1 μ m and a pre-plasma ahead of the target, the simulations show the production of the collimated proton beam with the maximum energy of about 10 MeV. This agrees with the experimental results obtained at the BELLA laser facility (I 5 × 18 W / cm2 , λ = 800 nm). Furthermore, the maximum proton energy dependence on different setups of the initialization, i.e., different angles of the laser incidence from the target normal axis, different gradient scales and distributions of the pre-plasma, was explored. This work was supported by LDRD funding from LBNL, provided by the U.S. DOE under Contract No. DE-AC02-05CH11231, and used resources of the NERSC, a DOE office of Science User Facility supported by the U.S. DOE under Contract No. DE-AC02-05CH11231.

  6. A General Event Location Algorithm with Applications to Eclipse and Station Line-of-Sight

    NASA Technical Reports Server (NTRS)

    Parker, Joel J. K.; Hughes, Steven P.

    2011-01-01

    A general-purpose algorithm for the detection and location of orbital events is developed. The proposed algorithm reduces the problem to a global root-finding problem by mapping events of interest (such as eclipses, station access events, etc.) to continuous, differentiable event functions. A stepping algorithm and a bracketing algorithm are used to detect and locate the roots. Examples of event functions and the stepping/bracketing algorithms are discussed, along with results indicating performance and accuracy in comparison to commercial tools across a variety of trajectories.

  7. A General Event Location Algorithm with Applications to Eclispe and Station Line-of-Sight

    NASA Technical Reports Server (NTRS)

    Parker, Joel J. K.; Hughes, Steven P.

    2011-01-01

    A general-purpose algorithm for the detection and location of orbital events is developed. The proposed algorithm reduces the problem to a global root-finding problem by mapping events of interest (such as eclipses, station access events, etc.) to continuous, differentiable event functions. A stepping algorithm and a bracketing algorithm are used to detect and locate the roots. Examples of event functions and the stepping/bracketing algorithms are discussed, along with results indicating performance and accuracy in comparison to commercial tools across a variety of trajectories.

  8. Data driven CAN node reliability assessment for manufacturing system

    NASA Astrophysics Data System (ADS)

    Zhang, Leiming; Yuan, Yong; Lei, Yong

    2017-01-01

    The reliability of the Controller Area Network(CAN) is critical to the performance and safety of the system. However, direct bus-off time assessment tools are lacking in practice due to inaccessibility of the node information and the complexity of the node interactions upon errors. In order to measure the mean time to bus-off(MTTB) of all the nodes, a novel data driven node bus-off time assessment method for CAN network is proposed by directly using network error information. First, the corresponding network error event sequence for each node is constructed using multiple-layer network error information. Then, the generalized zero inflated Poisson process(GZIP) model is established for each node based on the error event sequence. Finally, the stochastic model is constructed to predict the MTTB of the node. The accelerated case studies with different error injection rates are conducted on a laboratory network to demonstrate the proposed method, where the network errors are generated by a computer controlled error injection system. Experiment results show that the MTTB of nodes predicted by the proposed method agree well with observations in the case studies. The proposed data driven node time to bus-off assessment method for CAN networks can successfully predict the MTTB of nodes by directly using network error event data.

  9. Radiation hydrodynamic simulations of line-driven disk winds for ultra-fast outflows

    NASA Astrophysics Data System (ADS)

    Nomura, Mariko; Ohsuga, Ken; Takahashi, Hiroyuki R.; Wada, Keiichi; Yoshida, Tessei

    2016-02-01

    Using two-dimensional radiation hydrodynamic simulations, we investigate the origin of the ultra-fast outflows (UFOs) that are often observed in luminous active galactic nuclei (AGNs). We found that the radiation force due to the spectral lines generates strong winds (line-driven disk winds) that are launched from the inner region of accretion disks (˜30 Schwarzschild radii). A wide range of black hole masses (MBH) and Eddington ratios (ε) was investigated to study the conditions causing the line-driven winds. For MBH = 106-109 M⊙ and ε = 0.1-0.7, funnel-shaped disk winds appear, in which dense matter is accelerated outward with an opening angle of 70°-80° and with 10% of the speed of light. If we observe the wind along its direction, the velocity, the column density, and the ionization state are consistent with those of the observed UFOs. As long as obscuration by the torus does not affect the observation of X-ray bands, the UFOs could be statistically observed in about 13%-28% of the luminous AGNs, which is not inconsistent with the observed ratio (˜40%). We also found that the results are insensitive to the X-ray luminosity and the density of the disk surface. Thus, we can conclude that UFOs could exist in any luminous AGNs, such as narrow-line Seyfert 1s and quasars with ε > 0.1, with which fast line-driven winds are associated.

  10. Simulating Flaring Events via an Intelligent Cellular Automata Mechanism

    NASA Astrophysics Data System (ADS)

    Dimitropoulou, M.; Vlahos, L.; Isliker, H.; Georgoulis, M.

    2010-07-01

    We simulate flaring events through a Cellular Automaton (CA) model, in which, for the first time, we use observed vector magnetograms as initial conditions. After non-linear force free extrapolation of the magnetic field from the vector magnetograms, we identify magnetic discontinuities, using two alternative criteria: (1) the average magnetic field gradient, or (2) the normalized magnetic field curl (i.e. the current). Magnetic discontinuities are identified at the grid-sites where the magnetic field gradient or curl exceeds a specified threshold. We then relax the magnetic discontinuities according to the rules of Lu and Hamilton (1991) or Lu et al. (1993), i.e. we redistribute the magnetic field locally so that the discontinuities disappear. In order to simulate the flaring events, we consider several alternative scenarios with regard to: (1) The threshold above which magnetic discontinuities are identified (applying low, high, and height-dependent threshold values); (2) The driving process that occasionally causes new discontinuities (at randomly chosen grid sites, magnetic field increments are added that are perpendicular (or may-be also parallel) to the existing magnetic field). We address the question whether the coronal active region magnetic fields can indeed be considered to be in the state of self-organized criticality (SOC).

  11. Simulation and characterization of a laterally-driven inertial micro-switch

    DOE Office of Scientific and Technical Information (OSTI.GOV)

    Chen, Wenguo; Wang, Yang; Wang, Huiying

    2015-04-15

    A laterally-driven inertial micro-switch was designed and fabricated using surface micromachining technology. The dynamic response process was simulated by ANSYS software, which revealed the vibration process of movable electrode when the proof mass is shocked by acceleration in sensitive direction. The test results of fabricated inertial micro-switches with and without anti-shock beams indicated that the contact process of micro-switch with anti-shock beams is more reliable than the one without anti-shock beams. The test results indicated that three contact signals had been observed in the contact process of the inertial switch without anti-shock beams, and only one contact signal in themore » inertial switch with anti-shock beams, which demonstrated that the anti-shock beams can effectively constrain the vibration in non-sensitive direction.« less

  12. The simulation of shock- and impact-driven flows with Mie-Gruneisen equations of state

    NASA Astrophysics Data System (ADS)

    Ward, Geoffrey M.

    An investigation of shock- and impact-driven flows with Mie-Gruneisen equation of state derived from a linear shock-particle speed Hugoniot relationship is presented. Cartesian mesh methods using structured adaptive refinement are applied to simulate several flows of interest in an Eulerian frame of reference. The flows central to the investigation include planar Richtmyer-Meshkov instability, the impact of a sphere with a plate, and an impact-driven Mach stem. First, for multicomponent shock-driven flows, a dimensionally unsplit, spatially high-order, hybrid, center-difference, limiter methodology is developed. Effective switching between center-difference and upwinding schemes is achieved by a set of robust tolerance and Lax-entropy-based criteria [49]. Oscillations that result from such a mixed stencil scheme are minimized by requiring that the upwinding method approaches the center-difference method in smooth regions. The solver is then applied to investigate planar Richtmyer-Meshkov instability in the context of an equation of state comparison. Comparisons of simulations with materials modeled by isotropic stress Mie-Gruneisen equations of state derived from a linear shock-particle speed Hugoniot relationship [36,52] to those of perfect gases are made with the intention of exposing the role of the equation of state. First, results for single- and triple-mode planar Richtmyer-Meshkov instability between mid-ocean ridge basalt (MORB) and molybdenum modeled by Mie-Gruneisen equations of state are presented for the case of a reflected shock. The single-mode case is explored for incident shock Mach numbers of 1.5 and 2.5. Additionally, examined is single-mode Richtmyer-Meshkov instability when a reflected expansion wave is present for incident Mach numbers of 1.5 and 2.5. Comparison to perfect gas solutions in such cases yields a higher degree of similarity in start-up time and growth rate oscillations. Vorticity distribution and corrugation centerline shortly

  13. Variance Estimation, Design Effects, and Sample Size Calculations for Respondent-Driven Sampling

    PubMed Central

    2006-01-01

    Hidden populations, such as injection drug users and sex workers, are central to a number of public health problems. However, because of the nature of these groups, it is difficult to collect accurate information about them, and this difficulty complicates disease prevention efforts. A recently developed statistical approach called respondent-driven sampling improves our ability to study hidden populations by allowing researchers to make unbiased estimates of the prevalence of certain traits in these populations. Yet, not enough is known about the sample-to-sample variability of these prevalence estimates. In this paper, we present a bootstrap method for constructing confidence intervals around respondent-driven sampling estimates and demonstrate in simulations that it outperforms the naive method currently in use. We also use simulations and real data to estimate the design effects for respondent-driven sampling in a number of situations. We conclude with practical advice about the power calculations that are needed to determine the appropriate sample size for a study using respondent-driven sampling. In general, we recommend a sample size twice as large as would be needed under simple random sampling. PMID:16937083

  14. Comparison of Malaria Simulations Driven by Meteorological Observations and Reanalysis Products in Senegal

    PubMed Central

    Diouf, Ibrahima; Rodriguez-Fonseca, Belen; Deme, Abdoulaye; Caminade, Cyril; Morse, Andrew P.; Cisse, Moustapha; Sy, Ibrahima; Dia, Ibrahima; Ermert, Volker; Ndione, Jacques-André; Gaye, Amadou Thierno

    2017-01-01

    The analysis of the spatial and temporal variability of climate parameters is crucial to study the impact of climate-sensitive vector-borne diseases such as malaria. The use of malaria models is an alternative way of producing potential malaria historical data for Senegal due to the lack of reliable observations for malaria outbreaks over a long time period. Consequently, here we use the Liverpool Malaria Model (LMM), driven by different climatic datasets, in order to study and validate simulated malaria parameters over Senegal. The findings confirm that the risk of malaria transmission is mainly linked to climate variables such as rainfall and temperature as well as specific landscape characteristics. For the whole of Senegal, a lag of two months is generally observed between the peak of rainfall in August and the maximum number of reported malaria cases in October. The malaria transmission season usually takes place from September to November, corresponding to the second peak of temperature occurring in October. Observed malaria data from the Programme National de Lutte contre le Paludisme (PNLP, National Malaria control Programme in Senegal) and outputs from the meteorological data used in this study were compared. The malaria model outputs present some consistencies with observed malaria dynamics over Senegal, and further allow the exploration of simulations performed with reanalysis data sets over a longer time period. The simulated malaria risk significantly decreased during the 1970s and 1980s over Senegal. This result is consistent with the observed decrease of malaria vectors and malaria cases reported by field entomologists and clinicians in the literature. The main differences between model outputs and observations regard amplitude, but can be related not only to reanalysis deficiencies but also to other environmental and socio-economic factors that are not included in this mechanistic malaria model framework. The present study can be considered as a

  15. Comparison of Malaria Simulations Driven by Meteorological Observations and Reanalysis Products in Senegal.

    PubMed

    Diouf, Ibrahima; Rodriguez-Fonseca, Belen; Deme, Abdoulaye; Caminade, Cyril; Morse, Andrew P; Cisse, Moustapha; Sy, Ibrahima; Dia, Ibrahima; Ermert, Volker; Ndione, Jacques-André; Gaye, Amadou Thierno

    2017-09-25

    The analysis of the spatial and temporal variability of climate parameters is crucial to study the impact of climate-sensitive vector-borne diseases such as malaria. The use of malaria models is an alternative way of producing potential malaria historical data for Senegal due to the lack of reliable observations for malaria outbreaks over a long time period. Consequently, here we use the Liverpool Malaria Model (LMM), driven by different climatic datasets, in order to study and validate simulated malaria parameters over Senegal. The findings confirm that the risk of malaria transmission is mainly linked to climate variables such as rainfall and temperature as well as specific landscape characteristics. For the whole of Senegal, a lag of two months is generally observed between the peak of rainfall in August and the maximum number of reported malaria cases in October. The malaria transmission season usually takes place from September to November, corresponding to the second peak of temperature occurring in October. Observed malaria data from the Programme National de Lutte contre le Paludisme (PNLP, National Malaria control Programme in Senegal) and outputs from the meteorological data used in this study were compared. The malaria model outputs present some consistencies with observed malaria dynamics over Senegal, and further allow the exploration of simulations performed with reanalysis data sets over a longer time period. The simulated malaria risk significantly decreased during the 1970s and 1980s over Senegal. This result is consistent with the observed decrease of malaria vectors and malaria cases reported by field entomologists and clinicians in the literature. The main differences between model outputs and observations regard amplitude, but can be related not only to reanalysis deficiencies but also to other environmental and socio-economic factors that are not included in this mechanistic malaria model framework. The present study can be considered as a

  16. Simulation of Solar Heat Pump Dryer Directly Driven by Photovoltaic Panels

    NASA Astrophysics Data System (ADS)

    Houhou, H.; Yuan, W.; Wang, G.

    2017-05-01

    This paper investigates a new type of solar heat pump dryer directly driven by photovoltaic panels. In order to design this system, a mathematical model has been established describing the whole drying process, including models of key components and phenomena of heat and mass transfer at the product layer and the air. The results of simulation at different drying air temperatures and velocities have been calculated and it indicate that the temperature of drying air is crucial external parameter compared to the velocity, with the increase of drying temperature from 45°C to 55°C, the product moisture content (Kg water/Kg dry product) decreased from 0.75 Kg/Kg to 0.3 Kg/Kg.

  17. Simulation of Fast Neutronics in an Accelerator-Driven Sub-Critical Core

    NASA Astrophysics Data System (ADS)

    Gwyn Rosaire, C.; Sattarov, Akhdiyor; McIntyre, Peter; Tsvetkov, Pavel

    2011-10-01

    Accelerator-driven subcritical fission in a molten salt core (ADSMS) is being developed as a technology for green nuclear power. ADSMS burns its fertile fuel to completion, it cannot melt down, and it destroys long-lived minor actinides. The ADSMS core consists of a vessel filled with a molten salt eutectic of UCl3 and NaCl. The fast neutronics of ADSMS makes possible two unique benefits: isobreeding, a steady-state equilibrium in which ^238U is bred to ^239Pu and the ^239Pu fissions, and destruction of minor actinides, in which fission of the intermediary nuclides dominates of breeding. Results of simulations of the fast neutronics in the ADSMS core will be presented.

  18. Rare Event Simulation for T-cell Activation

    NASA Astrophysics Data System (ADS)

    Lipsmeier, Florian; Baake, Ellen

    2009-02-01

    The problem of statistical recognition is considered, as it arises in immunobiology, namely, the discrimination of foreign antigens against a background of the body's own molecules. The precise mechanism of this foreign-self-distinction, though one of the major tasks of the immune system, continues to be a fundamental puzzle. Recent progress has been made by van den Berg, Rand, and Burroughs (J. Theor. Biol. 209:465-486, 2001), who modelled the probabilistic nature of the interaction between the relevant cell types, namely, T-cells and antigen-presenting cells (APCs). Here, the stochasticity is due to the random sample of antigens present on the surface of every APC, and to the random receptor type that characterises individual T-cells. It has been shown previously (van den Berg et al. in J. Theor. Biol. 209:465-486, 2001; Zint et al. in J. Math. Biol. 57:841-861, 2008) that this model, though highly idealised, is capable of reproducing important aspects of the recognition phenomenon, and of explaining them on the basis of stochastic rare events. These results were obtained with the help of a refined large deviation theorem and were thus asymptotic in nature. Simulations have, so far, been restricted to the straightforward simple sampling approach, which does not allow for sample sizes large enough to address more detailed questions. Building on the available large deviation results, we develop an importance sampling technique that allows for a convenient exploration of the relevant tail events by means of simulation. With its help, we investigate the mechanism of statistical recognition in some depth. In particular, we illustrate how a foreign antigen can stand out against the self background if it is present in sufficiently many copies, although no a priori difference between self and nonself is built into the model.

  19. Development of a Wind Plant Large-Eddy Simulation with Measurement-Driven Atmospheric Inflow

    DOE Office of Scientific and Technical Information (OSTI.GOV)

    Quon, Eliot W.; Churchfield, Matthew J.; Cheung, Lawrence

    This paper details the development of an aeroelastic wind plant model with large-eddy simulation (LES). The chosen LES solver is the Simulator for Wind Farm Applications (SOWFA) based on the OpenFOAM framework, coupled to NREL's comprehensive aeroelastic analysis tool, FAST. An atmospheric boundary layer (ABL) precursor simulation was constructed based on assessments of meteorological tower, lidar, and radar data over a 3-hour window. This precursor was tuned to the specific atmospheric conditions that occurred both prior to and during the measurement campaign, enabling capture of a night-to-day transition in the turbulent ABL. In the absence of height-varying temperature measurements, spatiallymore » averaged radar data were sufficient to characterize the atmospheric stability of the wind plant in terms of the shear profile, and near-ground temperature sensors provided a reasonable estimate of the ground heating rate describing the morning transition. A full aeroelastic simulation was then performed for a subset of turbines within the wind plant, driven by the precursor. Analysis of two turbines within the array, one directly waked by the other, demonstrated good agreement with measured time-averaged loads.« less

  20. The Application of SNiPER to the JUNO Simulation

    NASA Astrophysics Data System (ADS)

    Lin, Tao; Zou, Jiaheng; Li, Weidong; Deng, Ziyan; Fang, Xiao; Cao, Guofu; Huang, Xingtao; You, Zhengyun; JUNO Collaboration

    2017-10-01

    The JUNO (Jiangmen Underground Neutrino Observatory) is a multipurpose neutrino experiment which is designed to determine neutrino mass hierarchy and precisely measure oscillation parameters. As one of the important systems, the JUNO offline software is being developed using the SNiPER software. In this proceeding, we focus on the requirements of JUNO simulation and present the working solution based on the SNiPER. The JUNO simulation framework is in charge of managing event data, detector geometries and materials, physics processes, simulation truth information etc. It glues physics generator, detector simulation and electronics simulation modules together to achieve a full simulation chain. In the implementation of the framework, many attractive characteristics of the SNiPER have been used, such as dynamic loading, flexible flow control, multiple event management and Python binding. Furthermore, additional efforts have been made to make both detector and electronics simulation flexible enough to accommodate and optimize different detector designs. For the Geant4-based detector simulation, each sub-detector component is implemented as a SNiPER tool which is a dynamically loadable and configurable plugin. So it is possible to select the detector configuration at runtime. The framework provides the event loop to drive the detector simulation and interacts with the Geant4 which is implemented as a passive service. All levels of user actions are wrapped into different customizable tools, so that user functions can be easily extended by just adding new tools. The electronics simulation has been implemented by following an event driven scheme. The SNiPER task component is used to simulate data processing steps in the electronics modules. The electronics and trigger are synchronized by triggered events containing possible physics signals. The JUNO simulation software has been released and is being used by the JUNO collaboration to do detector design optimization, event

  1. Modeling extreme (Carrington-type) space weather events using three-dimensional MHD code simulations

    NASA Astrophysics Data System (ADS)

    Ngwira, C. M.; Pulkkinen, A. A.; Kuznetsova, M. M.; Glocer, A.

    2013-12-01

    There is growing concern over possible severe societal consequences related to adverse space weather impacts on man-made technological infrastructure and systems. In the last two decades, significant progress has been made towards the modeling of space weather events. Three-dimensional (3-D) global magnetohydrodynamics (MHD) models have been at the forefront of this transition, and have played a critical role in advancing our understanding of space weather. However, the modeling of extreme space weather events is still a major challenge even for existing global MHD models. In this study, we introduce a specially adapted University of Michigan 3-D global MHD model for simulating extreme space weather events that have a ground footprint comparable (or larger) to the Carrington superstorm. Results are presented for an initial simulation run with ``very extreme'' constructed/idealized solar wind boundary conditions driving the magnetosphere. In particular, we describe the reaction of the magnetosphere-ionosphere system and the associated ground induced geoelectric field to such extreme driving conditions. We also discuss the results and what they might mean for the accuracy of the simulations. The model is further tested using input data for an observed space weather event to verify the MHD model consistence and to draw guidance for future work. This extreme space weather MHD model is designed specifically for practical application to the modeling of extreme geomagnetically induced electric fields, which can drive large currents in earth conductors such as power transmission grids.

  2. 14 CFR 36.9 - Acoustical change: Propeller-driven small airplanes and propeller-driven commuter category...

    Code of Federal Regulations, 2010 CFR

    2010-01-01

    ... airplanes and propeller-driven commuter category airplanes. 36.9 Section 36.9 Aeronautics and Space FEDERAL... AIRWORTHINESS CERTIFICATION General § 36.9 Acoustical change: Propeller-driven small airplanes and propeller-driven commuter category airplanes. For propeller-driven small airplanes in the primary, normal, utility...

  3. 14 CFR 36.9 - Acoustical change: Propeller-driven small airplanes and propeller-driven commuter category...

    Code of Federal Regulations, 2013 CFR

    2013-01-01

    ... airplanes and propeller-driven commuter category airplanes. 36.9 Section 36.9 Aeronautics and Space FEDERAL... AIRWORTHINESS CERTIFICATION General § 36.9 Acoustical change: Propeller-driven small airplanes and propeller-driven commuter category airplanes. For propeller-driven small airplanes in the primary, normal, utility...

  4. 14 CFR 36.9 - Acoustical change: Propeller-driven small airplanes and propeller-driven commuter category...

    Code of Federal Regulations, 2012 CFR

    2012-01-01

    ... airplanes and propeller-driven commuter category airplanes. 36.9 Section 36.9 Aeronautics and Space FEDERAL... AIRWORTHINESS CERTIFICATION General § 36.9 Acoustical change: Propeller-driven small airplanes and propeller-driven commuter category airplanes. For propeller-driven small airplanes in the primary, normal, utility...

  5. 14 CFR 36.9 - Acoustical change: Propeller-driven small airplanes and propeller-driven commuter category...

    Code of Federal Regulations, 2011 CFR

    2011-01-01

    ... airplanes and propeller-driven commuter category airplanes. 36.9 Section 36.9 Aeronautics and Space FEDERAL... AIRWORTHINESS CERTIFICATION General § 36.9 Acoustical change: Propeller-driven small airplanes and propeller-driven commuter category airplanes. For propeller-driven small airplanes in the primary, normal, utility...

  6. 14 CFR 36.9 - Acoustical change: Propeller-driven small airplanes and propeller-driven commuter category...

    Code of Federal Regulations, 2014 CFR

    2014-01-01

    ... airplanes and propeller-driven commuter category airplanes. 36.9 Section 36.9 Aeronautics and Space FEDERAL... AIRWORTHINESS CERTIFICATION General § 36.9 Acoustical change: Propeller-driven small airplanes and propeller-driven commuter category airplanes. For propeller-driven small airplanes in the primary, normal, utility...

  7. The use of discrete-event simulation modeling to compare handwritten and electronic prescribing systems.

    PubMed

    Ghany, Ahmad; Vassanji, Karim; Kuziemsky, Craig; Keshavjee, Karim

    2013-01-01

    Electronic prescribing (e-prescribing) is expected to bring many benefits to Canadian healthcare, such as a reduction in errors and adverse drug reactions. As there currently is no functioning e-prescribing system in Canada that is completely electronic, we are unable to evaluate the performance of a live system. An alternative approach is to use simulation modeling for evaluation. We developed two discrete-event simulation models, one of the current handwritten prescribing system and one of a proposed e-prescribing system, to compare the performance of these two systems. We were able to compare the number of processes in each model, workflow efficiency, and the distribution of patients or prescriptions. Although we were able to compare these models to each other, using discrete-event simulation software was challenging. We were limited in the number of variables we could measure. We discovered non-linear processes and feedback loops in both models that could not be adequately represented using discrete-event simulation software. Finally, interactions between entities in both models could not be modeled using this type of software. We have come to the conclusion that a more appropriate approach to modeling both the handwritten and electronic prescribing systems would be to use a complex adaptive systems approach using agent-based modeling or systems-based modeling.

  8. Discrete event simulation modelling of patient service management with Arena

    NASA Astrophysics Data System (ADS)

    Guseva, Elena; Varfolomeyeva, Tatyana; Efimova, Irina; Movchan, Irina

    2018-05-01

    This paper describes the simulation modeling methodology aimed to aid in solving the practical problems of the research and analysing the complex systems. The paper gives the review of a simulation platform sand example of simulation model development with Arena 15.0 (Rockwell Automation).The provided example of the simulation model for the patient service management helps to evaluate the workload of the clinic doctors, determine the number of the general practitioners, surgeons, traumatologists and other specialized doctors required for the patient service and develop recommendations to ensure timely delivery of medical care and improve the efficiency of the clinic operation.

  9. Optimized Hypervisor Scheduler for Parallel Discrete Event Simulations on Virtual Machine Platforms

    DOE Office of Scientific and Technical Information (OSTI.GOV)

    Yoginath, Srikanth B; Perumalla, Kalyan S

    2013-01-01

    With the advent of virtual machine (VM)-based platforms for parallel computing, it is now possible to execute parallel discrete event simulations (PDES) over multiple virtual machines, in contrast to executing in native mode directly over hardware as is traditionally done over the past decades. While mature VM-based parallel systems now offer new, compelling benefits such as serviceability, dynamic reconfigurability and overall cost effectiveness, the runtime performance of parallel applications can be significantly affected. In particular, most VM-based platforms are optimized for general workloads, but PDES execution exhibits unique dynamics significantly different from other workloads. Here we first present results frommore » experiments that highlight the gross deterioration of the runtime performance of VM-based PDES simulations when executed using traditional VM schedulers, quantitatively showing the bad scaling properties of the scheduler as the number of VMs is increased. The mismatch is fundamental in nature in the sense that any fairness-based VM scheduler implementation would exhibit this mismatch with PDES runs. We also present a new scheduler optimized specifically for PDES applications, and describe its design and implementation. Experimental results obtained from running PDES benchmarks (PHOLD and vehicular traffic simulations) over VMs show over an order of magnitude improvement in the run time of the PDES-optimized scheduler relative to the regular VM scheduler, with over 20 reduction in run time of simulations using up to 64 VMs. The observations and results are timely in the context of emerging systems such as cloud platforms and VM-based high performance computing installations, highlighting to the community the need for PDES-specific support, and the feasibility of significantly reducing the runtime overhead for scalable PDES on VM platforms.« less

  10. Probing the Magnetic Field Structure in Sgr A* on Black Hole Horizon Scales with Polarized Radiative Transfer Simulations

    NASA Astrophysics Data System (ADS)

    Gold, Roman; McKinney, Jonathan C.; Johnson, Michael D.; Doeleman, Sheperd S.

    2017-03-01

    Magnetic fields are believed to drive accretion and relativistic jets in black hole accretion systems, but the magnetic field structure that controls these phenomena remains uncertain. We perform general relativistic (GR) polarized radiative transfer of time-dependent three-dimensional GR magnetohydrodynamical simulations to model thermal synchrotron emission from the Galactic Center source Sagittarius A* (Sgr A*). We compare our results to new polarimetry measurements by the Event Horizon Telescope (EHT) and show how polarization in the visibility (Fourier) domain distinguishes and constrains accretion flow models with different magnetic field structures. These include models with small-scale fields in disks driven by the magnetorotational instability as well as models with large-scale ordered fields in magnetically arrested disks. We also consider different electron temperature and jet mass-loading prescriptions that control the brightness of the disk, funnel-wall jet, and Blandford-Znajek-driven funnel jet. Our comparisons between the simulations and observations favor models with ordered magnetic fields near the black hole event horizon in Sgr A*, though both disk- and jet-dominated emission can satisfactorily explain most of the current EHT data. We also discuss how the black hole shadow can be filled-in by jet emission or mimicked by the absence of funnel jet emission. We show that stronger model constraints should be possible with upcoming circular polarization and higher frequency (349 GHz) measurements.

  11. Probing the Magnetic Field Structure in Sgr A* on Black Hole Horizon Scales with Polarized Radiative Transfer Simulations

    DOE Office of Scientific and Technical Information (OSTI.GOV)

    Gold, Roman; McKinney, Jonathan C.; Johnson, Michael D.

    Magnetic fields are believed to drive accretion and relativistic jets in black hole accretion systems, but the magnetic field structure that controls these phenomena remains uncertain. We perform general relativistic (GR) polarized radiative transfer of time-dependent three-dimensional GR magnetohydrodynamical simulations to model thermal synchrotron emission from the Galactic Center source Sagittarius A* (Sgr A*). We compare our results to new polarimetry measurements by the Event Horizon Telescope (EHT) and show how polarization in the visibility (Fourier) domain distinguishes and constrains accretion flow models with different magnetic field structures. These include models with small-scale fields in disks driven by the magnetorotationalmore » instability as well as models with large-scale ordered fields in magnetically arrested disks. We also consider different electron temperature and jet mass-loading prescriptions that control the brightness of the disk, funnel-wall jet, and Blandford–Znajek-driven funnel jet. Our comparisons between the simulations and observations favor models with ordered magnetic fields near the black hole event horizon in Sgr A*, though both disk- and jet-dominated emission can satisfactorily explain most of the current EHT data. We also discuss how the black hole shadow can be filled-in by jet emission or mimicked by the absence of funnel jet emission. We show that stronger model constraints should be possible with upcoming circular polarization and higher frequency (349 GHz) measurements.« less

  12. Modeling CO2 air dispersion from gas driven lake eruptions

    NASA Astrophysics Data System (ADS)

    Chiodini, Giovanni; Costa, Antonio; Rouwet, Dmitri; Tassi, Franco

    2016-04-01

    The most tragic event of gas driven lake eruption occurred at Lake Nyos (Cameroon) on 21 August 1986, when a dense cloud of CO2 suffocated more than 1700 people and an uncounted number of animals in just one night. The event stimulated a series of researches aimed to understand gas origins, gas release mechanisms and strategies for gas hazard mitigation. Very few studies have been carried out for describing the transport of dense CO2 clouds in the atmosphere. Although from a theoretical point of view, gas dispersion can be fully studied by solving the complete equations system for mass, momentum and energy transport, in actual practice, different simplified models able to describe only specific phases or aspects have to be used. In order to simulate dispersion of a heavy gas and to assess the consequent hazard we used a model based on a shallow layer approach (TWODEE2). This technique which uses depth-averaged variables to describe the flow behavior of dense gas over complex topography represents a good compromise between the complexity of computational fluid dynamic models and the simpler integral models. Recently the model has been applied for simulating CO2 dispersion from natural gas emissions in Central Italy. The results have shown how the dispersion pattern is strongly affected by the intensity of gas release, the topography and the ambient wind speed. Here for the first time we applied TWODEE2 code to simulate the dispersion of the large CO2 clouds released by limnic eruptions. An application concerns the case of the 1986 event at lake Nyos. Some difficulties for the simulations were related to the lack of quantitative information: gas flux estimations are not well constrained, meteorological conditions are only qualitatively known, the digital model of the terrain is of poor quality. Different scenarios were taken into account in order to reproduce the qualitative observations available for such episode. The observations regard mainly the effects of gas on

  13. NEUTRINO-DRIVEN CONVECTION IN CORE-COLLAPSE SUPERNOVAE: HIGH-RESOLUTION SIMULATIONS

    DOE Office of Scientific and Technical Information (OSTI.GOV)

    Radice, David; Ott, Christian D.; Abdikamalov, Ernazar

    2016-03-20

    We present results from high-resolution semiglobal simulations of neutrino-driven convection in core-collapse supernovae. We employ an idealized setup with parameterized neutrino heating/cooling and nuclear dissociation at the shock front. We study the internal dynamics of neutrino-driven convection and its role in redistributing energy and momentum through the gain region. We find that even if buoyant plumes are able to locally transfer heat up to the shock, convection is not able to create a net positive energy flux and overcome the downward transport of energy from the accretion flow. Turbulent convection does, however, provide a significant effective pressure support to the accretionmore » flow as it favors the accumulation of energy, mass, and momentum in the gain region. We derive an approximate equation that is able to explain and predict the shock evolution in terms of integrals of quantities such as the turbulent pressure in the gain region or the effects of nonradial motion of the fluid. We use this relation as a way to quantify the role of turbulence in the dynamics of the accretion shock. Finally, we investigate the effects of grid resolution, which we change by a factor of 20 between the lowest and highest resolution. Our results show that the shallow slopes of the turbulent kinetic energy spectra reported in previous studies are a numerical artifact. Kolmogorov scaling is progressively recovered as the resolution is increased.« less

  14. Simulation of seismic events induced by CO2 injection at In Salah, Algeria

    NASA Astrophysics Data System (ADS)

    Verdon, James P.; Stork, Anna L.; Bissell, Rob C.; Bond, Clare E.; Werner, Maximilian J.

    2015-09-01

    Carbon capture and storage technology has the potential to reduce anthropogenic CO2 emissions. However, the geomechanical response of the reservoir and sealing caprocks must be modelled and monitored to ensure that injected CO2 is safely stored. To ensure confidence in model results, there is a clear need to develop ways of comparing model predictions with observations from the field. In this paper we develop an approach to simulate microseismic activity induced by injection, which allows us to compare geomechanical model predictions with observed microseismic activity. We apply this method to the In Salah CCS project, Algeria. A geomechanical reconstruction is used to simulate the locations, orientations and sizes of pre-existing fractures in the In Salah reservoir. The initial stress conditions, in combination with a history matched reservoir flow model, are used to determine when and where these fractures exceed Mohr-Coulomb limits, triggering failure. The sizes and orientations of fractures, and the stress conditions thereon, are used to determine the resulting micro-earthquake focal mechanisms and magnitudes. We compare our simulated event population with observations made at In Salah, finding good agreement between model and observations in terms of event locations, rates of seismicity, and event magnitudes.

  15. Analysis of convection-permitting simulations for capturing heavy rainfall events over Myanmar Region

    NASA Astrophysics Data System (ADS)

    Acierto, R. A. E.; Kawasaki, A.

    2017-12-01

    Perennial flooding due to heavy rainfall events causes strong impacts on the society and economy. With increasing pressures of rapid development and potential for climate change impacts, Myanmar experiences a rapid increase in disaster risk. Heavy rainfall hazard assessment is key on quantifying such disaster risk in both current and future conditions. Downscaling using Regional Climate Models (RCM) such as Weather Research and Forecast model have been used extensively for assessing such heavy rainfall events. However, usage of convective parameterizations can introduce large errors in simulating rainfall. Convective-permitting simulations have been used to deal with this problem by increasing the resolution of RCMs to 4km. This study focuses on the heavy rainfall events during the six-year (2010-2015) wet period season from May to September in Myanmar. The investigation primarily utilizes rain gauge observation for comparing downscaled heavy rainfall events in 4km resolution using ERA-Interim as boundary conditions using 12km-4km one-way nesting method. The study aims to provide basis for production of high-resolution climate projections over Myanmar in order to contribute for flood hazard and risk assessment.

  16. Data-driven clustering of rain events: microphysics information derived from macro-scale observations

    NASA Astrophysics Data System (ADS)

    Djallel Dilmi, Mohamed; Mallet, Cécile; Barthes, Laurent; Chazottes, Aymeric

    2017-04-01

    Rain time series records are generally studied using rainfall rate or accumulation parameters, which are estimated for a fixed duration (typically 1 min, 1 h or 1 day). In this study we use the concept of rain events. The aim of the first part of this paper is to establish a parsimonious characterization of rain events, using a minimal set of variables selected among those normally used for the characterization of these events. A methodology is proposed, based on the combined use of a genetic algorithm (GA) and self-organizing maps (SOMs). It can be advantageous to use an SOM, since it allows a high-dimensional data space to be mapped onto a two-dimensional space while preserving, in an unsupervised manner, most of the information contained in the initial space topology. The 2-D maps obtained in this way allow the relationships between variables to be determined and redundant variables to be removed, thus leading to a minimal subset of variables. We verify that such 2-D maps make it possible to determine the characteristics of all events, on the basis of only five features (the event duration, the peak rain rate, the rain event depth, the standard deviation of the rain rate event and the absolute rain rate variation of the order of 0.5). From this minimal subset of variables, hierarchical cluster analyses were carried out. We show that clustering into two classes allows the conventional convective and stratiform classes to be determined, whereas classification into five classes allows this convective-stratiform classification to be further refined. Finally, our study made it possible to reveal the presence of some specific relationships between these five classes and the microphysics of their associated rain events.

  17. M3D-K Simulations of Beam-Driven Alfven Eigenmodes in ASDEX-U

    NASA Astrophysics Data System (ADS)

    Wang, Ge; Fu, Guoyong; Lauber, Philipp; Schneller, Mirjam

    2013-10-01

    Core-localized Alfven eigenmodes are often observed in neutral beam-heated plasma in ASDEX-U tokamak. In this work, hybrid simulations with the global kinetic/MHD hybrid code M3D-K have been carried out to investigate the linear stability and nonlinear dynamics of beam-driven Alfven eigenmodes using experimental parameters and profiles of an ASDEX-U discharge. The safety factor q profile is weakly reversed with minimum q value about qmin = 3.0. The simulation results show that the n = 3 mode transits from a reversed shear Alfven eigenmode (RSAE) to a core-localized toroidal Alfven eigenmode (TAE) as qmin drops from 3.0 to 2.79, consistent with results from the stability code NOVA as well as the experimental measurement. The M3D-K results are being compared with those of the linear gyrokinetic stability code LIGKA for benchmark. The simulation results will also be compared with the measured mode frequency and mode structure. This work was funded by the Max-Planck/Princeton Center for Plasma Physics.

  18. A general software reliability process simulation technique

    NASA Technical Reports Server (NTRS)

    Tausworthe, Robert C.

    1991-01-01

    The structure and rationale of the generalized software reliability process, together with the design and implementation of a computer program that simulates this process are described. Given assumed parameters of a particular project, the users of this program are able to generate simulated status timelines of work products, numbers of injected anomalies, and the progress of testing, fault isolation, repair, validation, and retest. Such timelines are useful in comparison with actual timeline data, for validating the project input parameters, and for providing data for researchers in reliability prediction modeling.

  19. Reconnection-Driven Magnetohydrodynamic Turbulence in a Simulated Coronal-Hole Jet

    NASA Technical Reports Server (NTRS)

    Uritskiy, Vadim M.; Roberts, Merrill A.; DeVore, C. Richard; Karpen, Judith T.

    2017-01-01

    Extreme-ultraviolet and X-ray jets occur frequently in magnetically open coronal holes on the Sun, especially at high solar latitudes. Some of these jets are observed by white-light coronagraphs as they propagate through the outer corona toward the inner heliosphere, and it has been proposed that they give rise to microstreams and torsional Alfven waves detected in situ in the solar wind. To predict and understand the signatures of coronal-hole jets, we have performed a detailed statistical analysis of such a jet simulated with an adaptively refined magnetohydrodynamics model. The results confirm the generation and persistence of three-dimensional, reconnection-driven magnetic turbulence in the simulation. We calculate the spatial correlations of magnetic fluctuations within the jet and find that they agree best with the Meuller - Biskamp scaling model including intermittent current sheets of various sizes coupled via hydrodynamic turbulent cascade. The anisotropy of the magnetic fluctuations and the spatial orientation of the current sheets are consistent with an ensemble of nonlinear Alfven waves. These properties also reflect the overall collimated jet structure imposed by the geometry of the reconnecting magnetic field. A comparison with Ulysses observations shows that turbulence in the jet wake is in quantitative agreement with that in the fast solar wind.

  20. Teaching sexual history-taking skills using the Sexual Events Classification System.

    PubMed

    Fidler, Donald C; Petri, Justin Daniel; Chapman, Mark

    2010-01-01

    The authors review the literature about educational programs for teaching sexual history-taking skills and describe novel techniques for teaching these skills. Psychiatric residents enrolled in a brief sexual history-taking course that included instruction on the Sexual Events Classification System, feedback on residents' video-recorded interviews with simulated patients, discussion of videos that simulated bad interviews, simulated patients, and a competency scoring form to score a video of a simulated interview. After the course, residents completed an anonymous survey to assess the usefulness of the experience. After the course, most residents felt more comfortable taking sexual histories. They described the Sexual Events Classification System and simulated interviews as practical methods for teaching sexual history-taking skills. The Sexual Events Classification System and simulated patient experiences may serve as a practical model for teaching sexual history-taking skills to general psychiatric residents.

  1. Discrete-Event Simulation Models of Plasmodium falciparum Malaria

    PubMed Central

    McKenzie, F. Ellis; Wong, Roger C.; Bossert, William H.

    2008-01-01

    We develop discrete-event simulation models using a single “timeline” variable to represent the Plasmodium falciparum lifecycle in individual hosts and vectors within interacting host and vector populations. Where they are comparable our conclusions regarding the relative importance of vector mortality and the durations of host immunity and parasite development are congruent with those of classic differential-equation models of malaria, epidemiology. However, our results also imply that in regions with intense perennial transmission, the influence of mosquito mortality on malaria prevalence in humans may be rivaled by that of the duration of host infectivity. PMID:18668185

  2. Generalized Maintenance Trainer Simulator: Development of Hardware and Software. Final Report.

    ERIC Educational Resources Information Center

    Towne, Douglas M.; Munro, Allen

    A general purpose maintenance trainer, which has the potential to simulate a wide variety of electronic equipments without hardware changes or new computer programs, has been developed and field tested by the Navy. Based on a previous laboratory model, the Generalized Maintenance Trainer Simulator (GMTS) is a relatively low cost trainer that…

  3. Feedforward Categorization on AER Motion Events Using Cortex-Like Features in a Spiking Neural Network.

    PubMed

    Zhao, Bo; Ding, Ruoxi; Chen, Shoushun; Linares-Barranco, Bernabe; Tang, Huajin

    2015-09-01

    This paper introduces an event-driven feedforward categorization system, which takes data from a temporal contrast address event representation (AER) sensor. The proposed system extracts bio-inspired cortex-like features and discriminates different patterns using an AER based tempotron classifier (a network of leaky integrate-and-fire spiking neurons). One of the system's most appealing characteristics is its event-driven processing, with both input and features taking the form of address events (spikes). The system was evaluated on an AER posture dataset and compared with two recently developed bio-inspired models. Experimental results have shown that it consumes much less simulation time while still maintaining comparable performance. In addition, experiments on the Mixed National Institute of Standards and Technology (MNIST) image dataset have demonstrated that the proposed system can work not only on raw AER data but also on images (with a preprocessing step to convert images into AER events) and that it can maintain competitive accuracy even when noise is added. The system was further evaluated on the MNIST dynamic vision sensor dataset (in which data is recorded using an AER dynamic vision sensor), with testing accuracy of 88.14%.

  4. Watchable Wildlife and Demand-Driven General Education

    ERIC Educational Resources Information Center

    Alley, Richard B.

    2013-01-01

    The societal benefits of an educated citizenry may be lost if "customers" at tuition-driven universities demand less of what they pay for because they value a credential more than the education it represents. Insights from potential employers may help students see the value of education and demand their money's worth.

  5. Discrete event simulation and the resultant data storage system response in the operational mission environment of Jupiter-Saturn /Voyager/ spacecraft

    NASA Technical Reports Server (NTRS)

    Mukhopadhyay, A. K.

    1978-01-01

    The Data Storage Subsystem Simulator (DSSSIM) simulating (by ground software) occurrence of discrete events in the Voyager mission is described. Functional requirements for Data Storage Subsystems (DSS) simulation are discussed, and discrete event simulation/DSSSIM processing is covered. Four types of outputs associated with a typical DSSSIM run are presented, and DSSSIM limitations and constraints are outlined.

  6. The Dynamics of Small-Scale Turbulence Driven Flows

    NASA Astrophysics Data System (ADS)

    Beer, M. A.; Hammett, G. W.

    1997-11-01

    The dynamics of small-scale fluctuation driven flows are of great interest for micro-instability driven turbulence, since nonlinear toroidal simulations have shown that these flows play an important role in the regulation of the turbulence and transport levels. The gyrofluid treatment of these flows was shown to be accurate for times shorter than a bounce time.(Beer, M. A., Ph. D. thesis, Princeton University (1995).) Since the decorrelation times of the turbulence are generally shorter than a bounce time, our original hypothesis was that this description was adequate. Recent work(Hinton, F. L., Rosenbluth, M. N., and Waltz, R. E., International Sherwood Fusion Theory Conference (1997).) pointed out possible problems with this hypothesis, emphasizing the existence of a linearly undamped component of the flow which could build up in time and lower the final turbulence level. While our original gyrofluid model reproduces some aspects of the linear flow, there are differences between the long time gyrofluid and kinetic linear results in some cases. On the other hand, if the long time behavior of these flows is dominated by nonlinear damping (which seems reasonable), then the existing nonlinear gyrofluid simulations may be sufficiently accurate. We test these possibilities by modifying the gyrofluid description of these flows and diagnosing the flow evolution in nonlinear simulations.

  7. Pseudo-global warming controls on the intensity and morphology of extreme convective storm events

    NASA Astrophysics Data System (ADS)

    Trapp, R. J.

    2015-12-01

    This research seeks to answer the basic question of how current-day extreme convective storm events might be represented under future anthropogenic climate change. We adapt the "pseudo-global warming" (PGW) methodology employed by Lackmann (2013, 2015) and others, who have investigated flooding and tropical cyclone events under climate change. Here, we exploit coupled atmosphere-ocean GCM data contributed to the CMIP5 archive, and take the mean 3D atmospheric state simulated during May 1990-1999 and subtract it from that simulated during May 2090-2099. Such 3D changes in temperature, humidity, geopotential height, and winds are added to synoptic/meso-scale analyses (NAM-ANL) of specific events, and this modified atmospheric state is then used for initial and boundary conditions for real-data WRF model simulations of the events at high resolution. Comparison of an ensemble of these simulations with control (CTRL) simulations facilitates assessment of PGW effects. In contrast to the robust development of supercellular convection in our CTRL simulations, the combined effects of increased CIN and decreased forcing under PGW led to a failure of convection initiation in many of our ensemble members. Those members that had sufficient matching between the CIN and forcing tended to generate stronger convective updrafts than in the CTRL simulations, because of the relatively higher CAPE under PGW. And, the members with enhanced updrafts also tended to have enhanced vertical rotation. In fact, such mesocyclonic rotation and attendant supercellular morphology were even found in simulations that were driven with PGW-reduced environmental wind shear.

  8. Synchronous diversification of Sulawesi's iconic artiodactyls driven by recent geological events.

    PubMed

    Frantz, Laurent A F; Rudzinski, Anna; Nugraha, Abang Mansyursyah Surya; Evin, Allowen; Burton, James; Hulme-Beaman, Ardern; Linderholm, Anna; Barnett, Ross; Vega, Rodrigo; Irving-Pease, Evan K; Haile, James; Allen, Richard; Leus, Kristin; Shephard, Jill; Hillyer, Mia; Gillemot, Sarah; van den Hurk, Jeroen; Ogle, Sharron; Atofanei, Cristina; Thomas, Mark G; Johansson, Friederike; Mustari, Abdul Haris; Williams, John; Mohamad, Kusdiantoro; Damayanti, Chandramaya Siska; Wiryadi, Ita Djuwita; Obbles, Dagmar; Mona, Stephano; Day, Hally; Yasin, Muhammad; Meker, Stefan; McGuire, Jimmy A; Evans, Ben J; von Rintelen, Thomas; Ho, Simon Y W; Searle, Jeremy B; Kitchener, Andrew C; Macdonald, Alastair A; Shaw, Darren J; Hall, Robert; Galbusera, Peter; Larson, Greger

    2018-04-11

    The high degree of endemism on Sulawesi has previously been suggested to have vicariant origins, dating back to 40 Ma. Recent studies, however, suggest that much of Sulawesi's fauna assembled over the last 15 Myr. Here, we test the hypothesis that more recent uplift of previously submerged portions of land on Sulawesi promoted diversification and that much of its faunal assemblage is much younger than the island itself. To do so, we combined palaeogeographical reconstructions with genetic and morphometric datasets derived from Sulawesi's three largest mammals: the babirusa, anoa and Sulawesi warty pig. Our results indicate that although these species most likely colonized the area that is now Sulawesi at different times (14 Ma to 2-3 Ma), they experienced an almost synchronous expansion from the central part of the island. Geological reconstructions indicate that this area was above sea level for most of the last 4 Myr, unlike most parts of the island. We conclude that emergence of land on Sulawesi (approx. 1-2 Myr) may have allowed species to expand synchronously. Altogether, our results indicate that the establishment of the highly endemic faunal assemblage on Sulawesi was driven by geological events over the last few million years. © 2018 The Authors.

  9. Synchronous diversification of Sulawesi's iconic artiodactyls driven by recent geological events

    PubMed Central

    Rudzinski, Anna; Nugraha, Abang Mansyursyah Surya; Burton, James; Linderholm, Anna; Barnett, Ross; Vega, Rodrigo; Irving-Pease, Evan K.; Haile, James; Allen, Richard; Leus, Kristin; Shephard, Jill; Hillyer, Mia; Gillemot, Sarah; van den Hurk, Jeroen; Ogle, Sharron; Atofanei, Cristina; Thomas, Mark G.; Johansson, Friederike; Mustari, Abdul Haris; Williams, John; Mohamad, Kusdiantoro; Damayanti, Chandramaya Siska; Wiryadi, Ita Djuwita; Obbles, Dagmar; Mona, Stephano; Day, Hally; Yasin, Muhammad; Meker, Stefan; McGuire, Jimmy A.; Evans, Ben J.; von Rintelen, Thomas; Ho, Simon Y. W.; Searle, Jeremy B.; Kitchener, Andrew C.; Macdonald, Alastair A.; Hall, Robert; Galbusera, Peter

    2018-01-01

    The high degree of endemism on Sulawesi has previously been suggested to have vicariant origins, dating back to 40 Ma. Recent studies, however, suggest that much of Sulawesi's fauna assembled over the last 15 Myr. Here, we test the hypothesis that more recent uplift of previously submerged portions of land on Sulawesi promoted diversification and that much of its faunal assemblage is much younger than the island itself. To do so, we combined palaeogeographical reconstructions with genetic and morphometric datasets derived from Sulawesi's three largest mammals: the babirusa, anoa and Sulawesi warty pig. Our results indicate that although these species most likely colonized the area that is now Sulawesi at different times (14 Ma to 2–3 Ma), they experienced an almost synchronous expansion from the central part of the island. Geological reconstructions indicate that this area was above sea level for most of the last 4 Myr, unlike most parts of the island. We conclude that emergence of land on Sulawesi (approx. 1–2 Myr) may have allowed species to expand synchronously. Altogether, our results indicate that the establishment of the highly endemic faunal assemblage on Sulawesi was driven by geological events over the last few million years. PMID:29643207

  10. NON-SPATIAL CALIBRATIONS OF A GENERAL UNIT MODEL FOR ECOSYSTEM SIMULATIONS. (R825792)

    EPA Science Inventory

    General Unit Models simulate system interactions aggregated within one spatial unit of resolution. For unit models to be applicable to spatial computer simulations, they must be formulated generally enough to simulate all habitat elements within the landscape. We present the d...

  11. NON-SPATIAL CALIBRATIONS OF A GENERAL UNIT MODEL FOR ECOSYSTEM SIMULATIONS. (R827169)

    EPA Science Inventory

    General Unit Models simulate system interactions aggregated within one spatial unit of resolution. For unit models to be applicable to spatial computer simulations, they must be formulated generally enough to simulate all habitat elements within the landscape. We present the d...

  12. Numerical simulation diagnostics of a flash flood event in Jeddah, Saudi Arabia

    NASA Astrophysics Data System (ADS)

    Samman, Ahmad

    On 26 January 2011, a severe storm hit the city of Jeddah, the second largest city in the Kingdom of Saudi Arabia. The storm resulted in heavy rainfall, which produced a flash flood in a short period of time. This event caused at least eleven fatalities and more than 114 injuries. Unfortunately, the observed rainfall data are limited to the weather station at King Abdul Aziz International airport, which is north of the city, while the most extreme precipitation occurred over the southern part of the city. This observation was useful to compare simulation result even though it does not reflect the severity of the event. The Regional Atmospheric Modeling System (RAMS) developed at Colorado State University was used to study this storm event. RAMS simulations indicted that a quasi-stationary Mesoscale convective system developed over the city of Jeddah and lasted for several hours. It was the source of the huge amount of rainfall. The model computed a total rainfall of more than 110 mm in the southern part of the city, where the flash flood occurred. This precipitation estimation was confirmed by the actual observation of the weather radar. While the annual rainfall in Jeddah during the winter varies from 50 to 100 mm, the amount of the rainfall resulting from this storm event exceeded the climatological total annual rainfall. The simulation of this event showed that warm sea surface temperature, combined with high humidity in the lower atmosphere and a large amount of convective available potential energy (CAPE) provided a favorable environment for convection. It also showed the presence of a cyclonic system over the north and eastern parts of the Mediterranean Sea, and a subtropical anti-cyclone over Northeastern Africa that contributed to cold air advection bringing cold air to the Jeddah area. In addition, an anti-cyclone (blocking) centered over east and southeastern parts of the Arabian Peninsula and the Arabian Sea produced a low level jet over the southern

  13. A parallel algorithm for switch-level timing simulation on a hypercube multiprocessor

    NASA Technical Reports Server (NTRS)

    Rao, Hariprasad Nannapaneni

    1989-01-01

    The parallel approach to speeding up simulation is studied, specifically the simulation of digital LSI MOS circuitry on the Intel iPSC/2 hypercube. The simulation algorithm is based on RSIM, an event driven switch-level simulator that incorporates a linear transistor model for simulating digital MOS circuits. Parallel processing techniques based on the concepts of Virtual Time and rollback are utilized so that portions of the circuit may be simulated on separate processors, in parallel for as large an increase in speed as possible. A partitioning algorithm is also developed in order to subdivide the circuit for parallel processing.

  14. Optimal generalized multistep integration formulae for real-time digital simulation

    NASA Technical Reports Server (NTRS)

    Moerder, D. D.; Halyo, N.

    1985-01-01

    The problem of discretizing a dynamical system for real-time digital simulation is considered. Treating the system and its simulation as stochastic processes leads to a statistical characterization of simulator fidelity. A plant discretization procedure based on an efficient matrix generalization of explicit linear multistep discrete integration formulae is introduced, which minimizes a weighted sum of the mean squared steady-state and transient error between the system and simulator outputs.

  15. Three-Dimensional General-Relativistic Magnetohydrodynamic Simulations of Remnant Accretion Disks from Neutron Star Mergers: Outflows and r -Process Nucleosynthesis

    NASA Astrophysics Data System (ADS)

    Siegel, Daniel M.; Metzger, Brian D.

    2017-12-01

    The merger of binary neutron stars, or of a neutron star and a stellar-mass black hole, can result in the formation of a massive rotating torus around a spinning black hole. In addition to providing collimating media for γ -ray burst jets, unbound outflows from these disks are an important source of mass ejection and rapid neutron capture (r -process) nucleosynthesis. We present the first three-dimensional general-relativistic magnetohydrodynamic (GRMHD) simulations of neutrino-cooled accretion disks in neutron star mergers, including a realistic equation of state valid at low densities and temperatures, self-consistent evolution of the electron fraction, and neutrino cooling through an approximate leakage scheme. After initial magnetic field amplification by magnetic winding, we witness the vigorous onset of turbulence driven by the magnetorotational instability (MRI). The disk quickly reaches a balance between heating from MRI-driven turbulence and neutrino cooling, which regulates the midplane electron fraction to a low equilibrium value Ye≈0.1 . Over the 380-ms duration of the simulation, we find that a fraction ≈20 % of the initial torus mass is unbound in powerful outflows with asymptotic velocities v ≈0.1 c and electron fractions Ye≈0.1 - 0.25 . Postprocessing the outflows through a nuclear reaction network shows the production of a robust second- and third-peak r process. Though broadly consistent with the results of previous axisymmetric hydrodynamical simulations, extrapolation of our results to late times suggests that the total ejecta mass from GRMHD disks is significantly higher. Our results provide strong evidence that postmerger disk outflows are an important site for the r process.

  16. Three-Dimensional General-Relativistic Magnetohydrodynamic Simulations of Remnant Accretion Disks from Neutron Star Mergers: Outflows and r-Process Nucleosynthesis.

    PubMed

    Siegel, Daniel M; Metzger, Brian D

    2017-12-08

    The merger of binary neutron stars, or of a neutron star and a stellar-mass black hole, can result in the formation of a massive rotating torus around a spinning black hole. In addition to providing collimating media for γ-ray burst jets, unbound outflows from these disks are an important source of mass ejection and rapid neutron capture (r-process) nucleosynthesis. We present the first three-dimensional general-relativistic magnetohydrodynamic (GRMHD) simulations of neutrino-cooled accretion disks in neutron star mergers, including a realistic equation of state valid at low densities and temperatures, self-consistent evolution of the electron fraction, and neutrino cooling through an approximate leakage scheme. After initial magnetic field amplification by magnetic winding, we witness the vigorous onset of turbulence driven by the magnetorotational instability (MRI). The disk quickly reaches a balance between heating from MRI-driven turbulence and neutrino cooling, which regulates the midplane electron fraction to a low equilibrium value Y_{e}≈0.1. Over the 380-ms duration of the simulation, we find that a fraction ≈20% of the initial torus mass is unbound in powerful outflows with asymptotic velocities v≈0.1c and electron fractions Y_{e}≈0.1-0.25. Postprocessing the outflows through a nuclear reaction network shows the production of a robust second- and third-peak r process. Though broadly consistent with the results of previous axisymmetric hydrodynamical simulations, extrapolation of our results to late times suggests that the total ejecta mass from GRMHD disks is significantly higher. Our results provide strong evidence that postmerger disk outflows are an important site for the r process.

  17. Drift wave turbulence simulations in LAPD

    NASA Astrophysics Data System (ADS)

    Popovich, P.; Umansky, M.; Carter, T. A.; Auerbach, D. W.; Friedman, B.; Schaffner, D.; Vincena, S.

    2009-11-01

    We present numerical simulations of turbulence in LAPD plasmas using the 3D electromagnetic code BOUT (BOUndary Turbulence). BOUT solves a system of fluid moment equations in a general toroidal equlibrium geometry near the plasma boundary. The underlying assumptions for the validity of the fluid model are well satisfied for drift waves in LAPD plasmas (typical plasma parameters ne˜1x10^12cm-3, Te˜10eV, and B ˜1kG), which makes BOUT a perfect tool for simulating LAPD. We have adapted BOUT for the cylindrical geometry of LAPD and have extended the model to include the background flows required for simulations of recent bias-driven rotation experiments. We have successfully verified the code for several linear instabilities, including resistive drift waves, Kelvin-Helmholtz and rotation-driven interchange. We will discuss first non-linear simulations and quasi-stationary solutions with self-consistent plasma flows and saturated density profiles.

  18. Characterization of flood and precipitation events in Southwestern Germany and stochastic simulation of extreme precipitation (Project FLORIS-SV)

    NASA Astrophysics Data System (ADS)

    Florian, Ehmele; Michael, Kunz

    2016-04-01

    Several major flood events occurred in Germany in the past 15-20 years especially in the eastern parts along the rivers Elbe and Danube. Examples include the major floods of 2002 and 2013 with an estimated loss of about 2 billion Euros each. The last major flood events in the State of Baden-Württemberg in southwest Germany occurred in the years 1978 and 1993/1994 along the rivers Rhine and Neckar with an estimated total loss of about 150 million Euros (converted) each. Flood hazard originates from a combination of different meteorological, hydrological and hydraulic processes. Currently there is no defined methodology available for evaluating and quantifying the flood hazard and related risk for larger areas or whole river catchments instead of single gauges. In order to estimate the probable maximum loss for higher return periods (e.g. 200 years, PML200), a stochastic model approach is designed since observational data are limited in time and space. In our approach, precipitation is linearly composed of three elements: background precipitation, orographically-induces precipitation, and a convectively-driven part. We use linear theory of orographic precipitation formation for the stochastic precipitation model (SPM), which is based on fundamental statistics of relevant atmospheric variables. For an adequate number of historic flood events, the corresponding atmospheric conditions and parameters are determined in order to calculate a probability density function (pdf) for each variable. This method involves all theoretically possible scenarios which may not have happened, yet. This work is part of the FLORIS-SV (FLOod RISk Sparkassen Versicherung) project and establishes the first step of a complete modelling chain of the flood risk. On the basis of the generated stochastic precipitation event set, hydrological and hydraulic simulations will be performed to estimate discharge and water level. The resulting stochastic flood event set will be used to quantify the

  19. Simulations of a beam-driven plasma antenna in the regime of plasma transparency

    NASA Astrophysics Data System (ADS)

    Timofeev, I. V.; Berendeev, E. A.; Dudnikova, G. I.

    2017-09-01

    In this paper, the theoretically predicted possibility to increase the efficiency of electromagnetic radiation generated by a thin beam-plasma system in the regime of oblique emission, when a plasma column becomes transparent to radiation near the plasma frequency, is investigated using particle-in-cell simulations. If a finite-size plasma column has a longitudinal density modulation, such a system is able to radiate electromagnetic waves as a dipole antenna. This radiation mechanism is based on the conversion of an electron beam-driven potential plasma wave on the periodic perturbation of plasma density. In this case, the frequency of radiated waves appears to be slightly lower than the plasma frequency. That is why their fields enable the penetration into the plasma only to the skin-depth. This case is realized when the period of density modulation coincides with the wavelength of the most unstable beam-driven mode, and the produced radiation escapes from the plasma in the purely transverse direction. In the recent theoretical paper [I. V. Timofeev et al. Phys. Plasmas 23, 083119 (2016)], however, it has been found that the magnetized plasma can be transparent to this radiation at certain emission angles. It means that the beam-to-radiation power conversion can be highly efficient even in a relatively thick plasma since not only boundary layers but also the whole plasma volume can be involved in the generation of electromagnetic waves. Simulations of steady-state beam injection into a pre-modulated plasma channel confirm the existence of this effect and show limits of validity for the simplified theoretical model.

  20. Statistical and Probabilistic Extensions to Ground Operations' Discrete Event Simulation Modeling

    NASA Technical Reports Server (NTRS)

    Trocine, Linda; Cummings, Nicholas H.; Bazzana, Ashley M.; Rychlik, Nathan; LeCroy, Kenneth L.; Cates, Grant R.

    2010-01-01

    NASA's human exploration initiatives will invest in technologies, public/private partnerships, and infrastructure, paving the way for the expansion of human civilization into the solar system and beyond. As it is has been for the past half century, the Kennedy Space Center will be the embarkation point for humankind's journey into the cosmos. Functioning as a next generation space launch complex, Kennedy's launch pads, integration facilities, processing areas, launch and recovery ranges will bustle with the activities of the world's space transportation providers. In developing this complex, KSC teams work through the potential operational scenarios: conducting trade studies, planning and budgeting for expensive and limited resources, and simulating alternative operational schemes. Numerous tools, among them discrete event simulation (DES), were matured during the Constellation Program to conduct such analyses with the purpose of optimizing the launch complex for maximum efficiency, safety, and flexibility while minimizing life cycle costs. Discrete event simulation is a computer-based modeling technique for complex and dynamic systems where the state of the system changes at discrete points in time and whose inputs may include random variables. DES is used to assess timelines and throughput, and to support operability studies and contingency analyses. It is applicable to any space launch campaign and informs decision-makers of the effects of varying numbers of expensive resources and the impact of off nominal scenarios on measures of performance. In order to develop representative DES models, methods were adopted, exploited, or created to extend traditional uses of DES. The Delphi method was adopted and utilized for task duration estimation. DES software was exploited for probabilistic event variation. A roll-up process was used, which was developed to reuse models and model elements in other less - detailed models. The DES team continues to innovate and expand

  1. MHD simulation of the shock wave event on October 24, 2003

    NASA Astrophysics Data System (ADS)

    Ogino, T.; Kajiwara, Y.; Nakao, M.; Park, K. S.; Fukazawa, K.; Yi, Y.

    2007-11-01

    A three-dimensional global MHD simulation of the interaction between the solar wind and the Earth's magnetosphere has been executed to study the shock wave event on space weather problem on October 24, 2003, when an abnormal operation happened in a satellite for Environment Observation Technology, ADEOS-II (Midori-II). Characteristic features of the event are the long duration of southward IMF, arrival of a strong shock wave, then large variation of IMF By from negative to positive for about 15 min duration. In the simulation, the shock wave compresses the magnetosphere for southward IMF and a hot plasma was injected around the geosynchronous orbit from plasma sheet. During the interval when IMF By changes from negative to positive, the magnitude of IMF extremely decreases to bring attenuation of magnetic reconnection. The open-closed boundary shrinks in the polar cap and the transient expansion of the magnetic field lines occurs to imply enhancement of particle precipitation. The reconnection site moves from dawn to dusk in the dayside magnetopause and a narrow cockscomb closed field region is formed in the high latitude tail.

  2. Event detection and sub-state discovery from biomolecular simulations using higher-order statistics: application to enzyme adenylate kinase.

    PubMed

    Ramanathan, Arvind; Savol, Andrej J; Agarwal, Pratul K; Chennubhotla, Chakra S

    2012-11-01

    Biomolecular simulations at millisecond and longer time-scales can provide vital insights into functional mechanisms. Because post-simulation analyses of such large trajectory datasets can be a limiting factor in obtaining biological insights, there is an emerging need to identify key dynamical events and relating these events to the biological function online, that is, as simulations are progressing. Recently, we have introduced a novel computational technique, quasi-anharmonic analysis (QAA) (Ramanathan et al., PLoS One 2011;6:e15827), for partitioning the conformational landscape into a hierarchy of functionally relevant sub-states. The unique capabilities of QAA are enabled by exploiting anharmonicity in the form of fourth-order statistics for characterizing atomic fluctuations. In this article, we extend QAA for analyzing long time-scale simulations online. In particular, we present HOST4MD--a higher-order statistical toolbox for molecular dynamics simulations, which (1) identifies key dynamical events as simulations are in progress, (2) explores potential sub-states, and (3) identifies conformational transitions that enable the protein to access those sub-states. We demonstrate HOST4MD on microsecond timescale simulations of the enzyme adenylate kinase in its apo state. HOST4MD identifies several conformational events in these simulations, revealing how the intrinsic coupling between the three subdomains (LID, CORE, and NMP) changes during the simulations. Further, it also identifies an inherent asymmetry in the opening/closing of the two binding sites. We anticipate that HOST4MD will provide a powerful and extensible framework for detecting biophysically relevant conformational coordinates from long time-scale simulations. Copyright © 2012 Wiley Periodicals, Inc.

  3. Extreme Landfalling Atmospheric River Events in Arizona: Possible Future Changes

    NASA Astrophysics Data System (ADS)

    Singh, I.; Dominguez, F.

    2016-12-01

    Changing climate could impact the frequency and intensity of extreme atmospheric river events. This can have important consequences for regions like the Southwestern United Sates that rely upon AR-related precipitation for meeting their water demand and are prone to AR-related flooding. This study investigates the effects of climate change on extreme AR events in the Salt and Verde river basins in Central Arizona using a pseudo global warming method (PGW). First, the five most extreme events that affected the region were selected. High-resolution control simulations of these events using the Weather Research and Forecasting model realistically captured the magnitude and spatial distribution of precipitation. Subsequently, following the PGW approach, the WRF initial and lateral boundary conditions were perturbed. The perturbation signals were obtained from an ensemble of 9 General Circulation Models for two warming scenarios - Representative Concentration Pathway (RCP) 4.5 and RCP8.5. Several simulations were conducted changing the temperature and relative humidity fields. PGW simulations reveal that while the overall dynamics of the storms did not change significantly, there was marked strengthening of associated Integrated Vertical Transport (IVT) plumes. There was a general increase in the precipitation over the basins due to increased moisture availability, but heterogeneous spatial changes. Additionally, no significant changes in the strength of the pre-cold frontal low-level jet in the future simulations were observed.

  4. Localized and generalized simulated wear of resin composites.

    PubMed

    Barkmeier, W W; Takamizawa, T; Erickson, R L; Tsujimoto, A; Latta, M; Miyazaki, M

    2015-01-01

    A laboratory study was conducted to examine the wear of resin composite materials using both a localized and generalized wear simulation model. Twenty specimens each of seven resin composites (Esthet•X HD [HD], Filtek Supreme Ultra [SU], Herculite Ultra [HU], SonicFill [SF], Tetric EvoCeram Bulk Fill [TB], Venus Diamond [VD], and Z100 Restorative [Z]) were subjected to a wear challenge of 400,000 cycles for both localized and generalized wear in a Leinfelder-Suzuki wear simulator (Alabama machine). The materials were placed in custom cylinder-shaped stainless steel fixtures. A stainless steel ball bearing (r=2.387 mm) was used as the antagonist for localized wear, and a stainless steel, cylindrical antagonist with a flat tip was used for generalized wear. A water slurry of polymethylmethacrylate (PMMA) beads was used as the abrasive media. A noncontact profilometer (Proscan 2100) with Proscan software was used to digitize the surface contours of the pretest and posttest specimens. AnSur 3D software was used for wear assessment. For localized testing, maximum facet depth (μm) and volume loss (mm(3)) were used to compare the materials. The mean depth of the facet surface (μm) and volume loss (mm(3)) were used for comparison of the generalized wear specimens. A one-way analysis of variance (ANOVA) and Tukey post hoc test were used for data analysis of volume loss for both localized and generalized wear, maximum facet depth for localized wear, and mean depth of the facet for generalized wear. The results for localized wear simulation were as follows [mean (standard deviation)]: maximum facet depth (μm)--Z, 59.5 (14.7); HU, 99.3 (16.3); SU, 102.8 (13.8); HD, 110.2 (13.3); VD, 114.0 (10.3); TB, 125.5 (12.1); SF, 195.9 (16.9); volume loss (mm(3))--Z, 0.013 (0.002); SU, 0.026 (0.006); HU, 0.043 (0.008); VD, 0.057 (0.009); HD, 0.058 (0.014); TB, 0.061 (0.010); SF, 0.135 (0.024). Generalized wear simulation results were as follows: mean depth of facet (μm)--Z, 9.3 (3

  5. Baseline Preferences for Daily, Event-Driven, or Periodic HIV Pre-Exposure Prophylaxis among Gay and Bisexual Men in the PRELUDE Demonstration Project.

    PubMed

    Vaccher, Stefanie J; Gianacas, Christopher; Templeton, David J; Poynten, Isobel M; Haire, Bridget G; Ooi, Catriona; Foster, Rosalind; McNulty, Anna; Grulich, Andrew E; Zablotska, Iryna B

    2017-01-01

    The effectiveness of daily pre-exposure prophylaxis (PrEP) is well established. However, there has been increasing interest in non-daily dosing schedules among gay and bisexual men (GBM). This paper explores preferences for PrEP dosing schedules among GBM at baseline in the PRELUDE demonstration project. Individuals at high-risk of HIV were enrolled in a free PrEP demonstration project in New South Wales, Australia, between November 2014 and April 2016. At baseline, they completed an online survey containing detailed behavioural, demographic, and attitudinal questions, including their ideal way to take PrEP: daily (one pill taken every day), event-driven (pills taken only around specific risk events), or periodic (daily dosing during periods of increased risk). Overall, 315 GBM (98% of study sample) provided a preferred PrEP dosing schedule at baseline. One-third of GBM expressed a preference for non-daily PrEP dosing: 20% for event-driven PrEP, and 14% for periodic PrEP. Individuals with a trade/vocational qualification were more likely to prefer periodic to daily PrEP [adjusted odds ratio (aOR) = 4.58, 95% confidence intervals (95% CI): (1.68, 12.49)], compared to individuals whose highest level of education was high school. Having an HIV-positive main regular partner was associated with strong preference for daily, compared to event-driven PrEP [aOR = 0.20, 95% CI: (0.04, 0.87)]. Participants who rated themselves better at taking medications were more likely to prefer daily over periodic PrEP [aOR = 0.39, 95% CI: (0.20, 0.76)]. Individuals' preferences for PrEP schedules are associated with demographic and behavioural factors that may impact on their ability to access health services and information about PrEP and patterns of HIV risk. At the time of data collection, there were limited data available about the efficacy of non-daily PrEP schedules, and clinicians only recommended daily PrEP to study participants. Further research investigating how

  6. Numerical simulation of a mistral wind event occuring

    NASA Astrophysics Data System (ADS)

    Guenard, V.; Caccia, J. L.; Tedeschi, G.

    2003-04-01

    The experimental network of the ESCOMPTE field experiment (june-july 2001) is turned into account to investigate the Mistral wind affecting the Marseille area (South of France). Mistral wind is a northerly flow blowing across the Rhône valley and toward the Mediterranean sea resulting from the dynamical low pressure generated in the wake of the Alps ridge. It brings cold, dry air masses and clear sky conditions over the south-eastern part of France. Up to now, few scientific studies have been carried out on the Mistral wind especially the evolution of its 3-D structure so that its mesoscale numerical simulation is still relevant. Non-hydrostatic RAMS model is performed to better investigate this mesoscale phenomena. Simulations at a 12 km horizontal resolution are compared to boundary layer wind profilers and ground measurements. Preliminary results suit quite well with the Mistral statistical studies carried out by the operational service of Météo-France and observed wind profiles are correctly reproduced by the numerical model RAMS which appears to be an efficient tool for its understanding of Mistral. Owing to the absence of diabatic effect in Mistral events which complicates numerical simulations, the present work is the first step for the validation of RAMS model in that area. Further works will consist on the study of the interaction of Mistral wind with land-sea breeze. Also, RAMS simulations will be combined with aerosol production and ocean circulation models to supply chemists and oceanographers with some answers for their studies.

  7. Estimating ICU bed capacity using discrete event simulation.

    PubMed

    Zhu, Zhecheng; Hen, Bee Hoon; Teow, Kiok Liang

    2012-01-01

    The intensive care unit (ICU) in a hospital caters for critically ill patients. The number of the ICU beds has a direct impact on many aspects of hospital performance. Lack of the ICU beds may cause ambulance diversion and surgery cancellation, while an excess of ICU beds may cause a waste of resources. This paper aims to develop a discrete event simulation (DES) model to help the healthcare service providers determine the proper ICU bed capacity which strikes the balance between service level and cost effectiveness. The DES model is developed to reflect the complex patient flow of the ICU system. Actual operational data, including emergency arrivals, elective arrivals and length of stay, are directly fed into the DES model to capture the variations in the system. The DES model is validated by open box test and black box test. The validated model is used to test two what-if scenarios which the healthcare service providers are interested in: the proper number of the ICU beds in service to meet the target rejection rate and the extra ICU beds in service needed to meet the demand growth. A 12-month period of actual operational data was collected from an ICU department with 13 ICU beds in service. Comparison between the simulation results and the actual situation shows that the DES model accurately captures the variations in the system, and the DES model is flexible to simulate various what-if scenarios. DES helps the healthcare service providers describe the current situation, and simulate the what-if scenarios for future planning.

  8. Development of a Wind Plant Large-Eddy Simulation with Measurement-Driven Atmospheric Inflow: Preprint

    DOE Office of Scientific and Technical Information (OSTI.GOV)

    Quon, Eliot; Churchfield, Matthew; Cheung, Lawrence

    This paper details the development of an aeroelastic wind plant model with large-eddy simulation (LES). The chosen LES solver is the Simulator for Wind Farm Applications (SOWFA) based on the OpenFOAM framework, coupled to NREL's comprehensive aeroelastic analysis tool, FAST. An atmospheric boundary layer (ABL) precursor simulation was constructed based on assessments of meteorological tower, lidar, and radar data over a 3-hour window. This precursor was tuned to the specific atmospheric conditions that occurred both prior to and during the measurement campaign, enabling capture of a night-to-day transition in the turbulent ABL. In the absence of height-varying temperature measurements, spatiallymore » averaged radar data were sufficient to characterize the atmospheric stability of the wind plant in terms of the shear profile, and near-ground temperature sensors provided a reasonable estimate of the ground heating rate describing the morning transition. A full aeroelastic simulation was then performed for a subset of turbines within the wind plant, driven by the precursor. Analysis of two turbines within the array, one directly waked by the other, demonstrated good agreement with measured time-averaged loads.« less

  9. Evaluation of a subject-specific, torque-driven computer simulation model of one-handed tennis backhand groundstrokes.

    PubMed

    Kentel, Behzat B; King, Mark A; Mitchell, Sean R

    2011-11-01

    A torque-driven, subject-specific 3-D computer simulation model of the impact phase of one-handed tennis backhand strokes was evaluated by comparing performance and simulation results. Backhand strokes of an elite subject were recorded on an artificial tennis court. Over the 50-ms period after impact, good agreement was found with an overall RMS difference of 3.3° between matching simulation and performance in terms of joint and racket angles. Consistent with previous experimental research, the evaluation process showed that grip tightness and ball impact location are important factors that affect postimpact racket and arm kinematics. Associated with these factors, the model can be used for a better understanding of the eccentric contraction of the wrist extensors during one-handed backhand ground strokes, a hypothesized mechanism of tennis elbow.

  10. Schematic driven silicon photonics design

    NASA Astrophysics Data System (ADS)

    Chrostowski, Lukas; Lu, Zeqin; Flückiger, Jonas; Pond, James; Klein, Jackson; Wang, Xu; Li, Sarah; Tai, Wei; Hsu, En Yao; Kim, Chan; Ferguson, John; Cone, Chris

    2016-03-01

    Electronic circuit designers commonly start their design process with a schematic, namely an abstract representation of the physical circuit. In integrated photonics on the other hand, it is very common for the design to begin at the physical component level. In order to build large integrated photonic systems, it is crucial to design using a schematic-driven approach. This includes simulations based on schematics, schematic-driven layout, layout versus schematic verification, and post-layout simulations. This paper describes such a design framework implemented using Mentor Graphics and Lumerical Solutions design tools. In addition, we describe challenges in silicon photonics related to manufacturing, and how these can be taken into account in simulations and how these impact circuit performance.

  11. CFD simulation of an unbaffled stirred tank reactor driven by a magnetic rod: assessment of turbulence models.

    PubMed

    Li, Jiajia; Deng, Baoqing; Zhang, Bing; Shen, Xiuzhong; Kim, Chang Nyung

    2015-01-01

    A simulation of an unbaffled stirred tank reactor driven by a magnetic stirring rod was carried out in a moving reference frame. The free surface of unbaffled stirred tank was captured by Euler-Euler model coupled with the volume of fluid (VOF) method. The re-normalization group (RNG) k-ɛ model, large eddy simulation (LES) model and detached eddy simulation (DES) model were evaluated for simulating the flow field in the stirred tank. All turbulence models can reproduce the tangential velocity in an unbaffled stirred tank with a rotational speed of 150 rpm, 250 rpm and 400 rpm, respectively. Radial velocity is underpredicted by the three models. LES model and RNG k-ɛ model predict the better tangential velocity and axial velocity, respectively. RNG k-ɛ model is recommended for the simulation of the flow in an unbaffled stirred tank with magnetic rod due to its computational effort.

  12. A Madden-Julian oscillation event realistically simulated by a global cloud-resolving model.

    PubMed

    Miura, Hiroaki; Satoh, Masaki; Nasuno, Tomoe; Noda, Akira T; Oouchi, Kazuyoshi

    2007-12-14

    A Madden-Julian Oscillation (MJO) is a massive weather event consisting of deep convection coupled with atmospheric circulation, moving slowly eastward over the Indian and Pacific Oceans. Despite its enormous influence on many weather and climate systems worldwide, it has proven very difficult to simulate an MJO because of assumptions about cumulus clouds in global meteorological models. Using a model that allows direct coupling of the atmospheric circulation and clouds, we successfully simulated the slow eastward migration of an MJO event. Topography, the zonal sea surface temperature gradient, and interplay between eastward- and westward-propagating signals controlled the timing of the eastward transition of the convective center. Our results demonstrate the potential making of month-long MJO predictions when global cloud-resolving models with realistic initial conditions are used.

  13. Influence of generalized complexity of a musical event on subjective time estimation.

    PubMed

    Bueno, José Lino Oliveira; Firmino, Erico Artioli; Engelman, Arno

    2002-04-01

    This study examined the variations in the apparent duration of music events produced by differences in their generalized compositional complexity. Stimuli were the first 90 sec. of Gustav Mahler's 3rd Movement of Symphony No. 2 (low complexity) and the first 90 sec. of Luciano Bério's 3rd Movement of Symphony for Eight Voices and Orchestra (high complexity). Bério's symphony is another "reading" of Mahler's. On the compositional base of Mahler's symphony, Bério explored complexity in several musical elements--temporal (i.e., rhythm), nontemporal (i.e., pitch, orchestral and vocal timbre, texture, density), and verbal (i.e., text, words, phonemes). These two somewhat differently filled durations were reproduced by 10 women and 6 men with a stopwatch under the prospective paradigm. Analysis showed that the more generalized complexity of the musical event was followed by greater subjective estimation of the duration of this 90-sec. symphonic excerpt.

  14. Reconnection-driven Magnetohydrodynamic Turbulence in a Simulated Coronal-hole Jet

    DOE Office of Scientific and Technical Information (OSTI.GOV)

    Uritsky, Vadim M.; Roberts, Merrill A.; DeVore, C. Richard

    Extreme-ultraviolet and X-ray jets occur frequently in magnetically open coronal holes on the Sun, especially at high solar latitudes. Some of these jets are observed by white-light coronagraphs as they propagate through the outer corona toward the inner heliosphere, and it has been proposed that they give rise to microstreams and torsional Alfvén waves detected in situ in the solar wind. To predict and understand the signatures of coronal-hole jets, we have performed a detailed statistical analysis of such a jet simulated by an adaptively refined magnetohydrodynamics model. The results confirm the generation and persistence of three-dimensional, reconnection-driven magnetic turbulencemore » in the simulation. We calculate the spatial correlations of magnetic fluctuations within the jet and find that they agree best with the Müller–Biskamp scaling model including intermittent current sheets of various sizes coupled via hydrodynamic turbulent cascade. The anisotropy of the magnetic fluctuations and the spatial orientation of the current sheets are consistent with an ensemble of nonlinear Alfvén waves. These properties also reflect the overall collimated jet structure imposed by the geometry of the reconnecting magnetic field. A comparison with Ulysses observations shows that turbulence in the jet wake is in quantitative agreement with that in the fast solar wind.« less

  15. ADVANCED WAVEFORM SIMULATION FOR SEISMIC MONITORING EVENTS

    DOE Office of Scientific and Technical Information (OSTI.GOV)

    Helmberger, Donald V.; Tromp, Jeroen; Rodgers, Arthur J.

    2008-10-17

    This quarter, we have focused on several tasks: (1) Building a high-quality catalog of earthquake source parameters for the Middle East and East Asia. In East Asia, we computed source parameters using the CAP method for a set of events studied by Herrman et al., (MRR, 2006) using a complete waveform technique. Results indicated excellent agreement with the moment magnitudes in the range 3.5 -5.5. Below magnitude 3.5 the scatter increases. For events with more than 2-3 observations at different azimuths, we found good agreement of focal mechanisms. Depths were generally consistent, although differences of up to 10 km weremore » found. These results suggest that CAP modeling provides estimates of source parameters at least as reliable as complete waveform modeling techniques. However, East Asia and the Yellow Sea Korean Paraplatform (YSKP) region studied are relatively laterally homogeneous and may not benefit from the CAP method’s flexibility to shift waveform segments to account for path-dependent model errors. A more challenging region to study is the Middle East where strong variations in sedimentary basin, crustal thickness and crustal and mantle seismic velocities greatly impact regional wave propagation. We applied the CAP method to a set of events in and around Iran and found good agreement between estimated focal mechanisms and those reported by the Global Centroid Moment Tensor (CMT) catalog. We found a possible bias in the moment magnitudes that may be due to the thick low-velocity crust in the Iranian Plateau. (2) Testing Methods on a Lifetime Regional Data Set. In particular, the recent 2/21/08 Nevada Event and Aftershock Sequence occurred in the middle of USArray, producing over a thousand records per event. The tectonic setting is quite similar to Central Iran and thus provides an excellent testbed for CAP+ at ranges out to 10°, including extensive observations of crustal thinning and thickening and various Pnl complexities. Broadband modeling in

  16. Evolution of Starburst Galaxies in the Illustris Simulation

    NASA Astrophysics Data System (ADS)

    Wilkinson, C. L.; Pimbblet, K. A.; Stott, J. P.; Few, C. G.; Gibson, B. K.

    2018-06-01

    There is a consensus in the literature that starburst galaxies are triggered by interaction events. However, it remains an open question as to what extent both merging and non-merging interactions have in triggering starbursts? In this study, we make use of the Illustris simulation to test how different triggering mechanisms can effect starburst events. We examine star formation rate, colour and environment of starburst galaxies to determine if this could be why we witness a bimodality in post-starburst populations within observational studies. Further, we briefly test the extent of quenching due to AGN feedback. From Illustris, we select 196 starburst galaxies at z = 0.15 and split them into post-merger and pre-merger/harassment driven starburst samples. We find that 55% of this sample not undergone a merger in the past 2 Gyr. Both of our samples are located in low-density environments within the filament regions of the cosmic web, however we find that pre-merger/harassment driven starburst are in higher density environments than post-merger driven starbursts. We also find that pre-merger/harassment starbursts are redder than post-merger starbursts, this could be driven by environmental effects. Both however, produce nuclear starbursts of comparable strengths.

  17. Particle-in-cell simulations of the lower-hybrid instability driven by an ion-ring distribution

    NASA Astrophysics Data System (ADS)

    Swanekamp, Stephen; Richardson, Steve; Mithaiwala, Manish; Crabtree, Chris

    2013-10-01

    Fully electromagnetic particle-in-cell simulations of the excitation of the lower-hybrid mode in a plasma driven by an ion-ring distribution using the Lsp code are presented. At early times the simulations agree with linear theory. The resulting wave evolution and non-linear plasma and ring-ion heating are compared with theoretical models [Mithaiwala et al. 2010; Crabtree et al., this meeting] and previous simulation results [Winske and Daughton, 2012]. 2D simulations show that when the magnetic field is perpendicular to the wave vector, k, the electrostatic potential fluctuations work in conjunction with the applied magnetic field causing a circular electron E ×B drift around a positively charged center. Similar phenomena are observed in 2D simulations of magnetic-field penetration into a spatially inhomogeneous unmagnetized plasma [Richardson et al., this meeting] where circular paramagnetic vortices are formed. These vortices are altered by the addition of a small, in-plane, component of magnetic field which allows electrons to stream along field lines effectively shorting out one component of the electric field. In this case, the vortex structures are no longer circular but elongated along the direction of the in-plane magnetic field component.

  18. Exact subthreshold integration with continuous spike times in discrete-time neural network simulations.

    PubMed

    Morrison, Abigail; Straube, Sirko; Plesser, Hans Ekkehard; Diesmann, Markus

    2007-01-01

    Very large networks of spiking neurons can be simulated efficiently in parallel under the constraint that spike times are bound to an equidistant time grid. Within this scheme, the subthreshold dynamics of a wide class of integrate-and-fire-type neuron models can be integrated exactly from one grid point to the next. However, the loss in accuracy caused by restricting spike times to the grid can have undesirable consequences, which has led to interest in interpolating spike times between the grid points to retrieve an adequate representation of network dynamics. We demonstrate that the exact integration scheme can be combined naturally with off-grid spike events found by interpolation. We show that by exploiting the existence of a minimal synaptic propagation delay, the need for a central event queue is removed, so that the precision of event-driven simulation on the level of single neurons is combined with the efficiency of time-driven global scheduling. Further, for neuron models with linear subthreshold dynamics, even local event queuing can be avoided, resulting in much greater efficiency on the single-neuron level. These ideas are exemplified by two implementations of a widely used neuron model. We present a measure for the efficiency of network simulations in terms of their integration error and show that for a wide range of input spike rates, the novel techniques we present are both more accurate and faster than standard techniques.

  19. Event Detection and Sub-state Discovery from Bio-molecular Simulations Using Higher-Order Statistics: Application To Enzyme Adenylate Kinase

    PubMed Central

    Ramanathan, Arvind; Savol, Andrej J.; Agarwal, Pratul K.; Chennubhotla, Chakra S.

    2012-01-01

    Biomolecular simulations at milli-second and longer timescales can provide vital insights into functional mechanisms. Since post-simulation analyses of such large trajectory data-sets can be a limiting factor in obtaining biological insights, there is an emerging need to identify key dynamical events and relating these events to the biological function online, that is, as simulations are progressing. Recently, we have introduced a novel computational technique, quasi-anharmonic analysis (QAA) (PLoS One 6(1): e15827), for partitioning the conformational landscape into a hierarchy of functionally relevant sub-states. The unique capabilities of QAA are enabled by exploiting anharmonicity in the form of fourth-order statistics for characterizing atomic fluctuations. In this paper, we extend QAA for analyzing long time-scale simulations online. In particular, we present HOST4MD - a higher-order statistical toolbox for molecular dynamics simulations, which (1) identifies key dynamical events as simulations are in progress, (2) explores potential sub-states and (3) identifies conformational transitions that enable the protein to access those sub-states. We demonstrate HOST4MD on micro-second time-scale simulations of the enzyme adenylate kinase in its apo state. HOST4MD identifies several conformational events in these simulations, revealing how the intrinsic coupling between the three sub-domains (LID, CORE and NMP) changes during the simulations. Further, it also identifies an inherent asymmetry in the opening/closing of the two binding sites. We anticipate HOST4MD will provide a powerful and extensible framework for detecting biophysically relevant conformational coordinates from long time-scale simulations. PMID:22733562

  20. Effect of Technology Driven Agricultural Land Use Change on Regional Hydroclimate

    NASA Astrophysics Data System (ADS)

    Arritt, R. W.; Sines, T. R.; Groisman, P. Y.; Gelder, B. K.

    2017-12-01

    During the mid-20th century motorized equipment replaced work animals in the central U.S. This led to a 95% decrease in farmland for producing oats, which had mostly been used as feed for horses. Much of this land was converted to more profitable crops such as soybeans and maize. The same period also saw a strong shift of the central U.S. precipitation intensity spectrum toward heavier events. Was this a coincidence, or is there a causal relationship? We investigate possible connections between this technology-driven land use change and regional hydroclimate by performing multi-decadal simulations over the central U.S. using the WRF-ARW regional climate model coupled with the Community Land Model (CLM 4.5). Cropland planted in maize, soybean, winter wheat, small grains (which includes oats and spring wheat), and other C3 and C4 crops were reconstructed on a decade by decade basis from 1940-2010 using county-level crop data. These crop distributions were used as land surface boundary conditions for two multi-decadal regional climate simulations, one with 1940s land use and another with modern (circa 2010) land use. Modern land use produced a shift in the simulated daily precipitation intensity spectrum toward heavy events, with higher frequencies of heavy precipitation amounts and lower frequencies of light amounts compared to 1940s land use. The results suggest that replacement of work animals by mechanized transport led to land use changes that produced about 10-30% of the observed trend toward more intense precipitation over the central United States. We therefore recommend that policy- and technology-driven changes in crop type be taken into account when projecting future climate and water resources.

  1. Exploration Supply Chain Simulation

    NASA Technical Reports Server (NTRS)

    2008-01-01

    The Exploration Supply Chain Simulation project was chartered by the NASA Exploration Systems Mission Directorate to develop a software tool, with proper data, to quantitatively analyze supply chains for future program planning. This tool is a discrete-event simulation that uses the basic supply chain concepts of planning, sourcing, making, delivering, and returning. This supply chain perspective is combined with other discrete or continuous simulation factors. Discrete resource events (such as launch or delivery reviews) are represented as organizational functional units. Continuous resources (such as civil service or contractor program functions) are defined as enabling functional units. Concepts of fixed and variable costs are included in the model to allow the discrete events to interact with cost calculations. The definition file is intrinsic to the model, but a blank start can be initiated at any time. The current definition file is an Orion Ares I crew launch vehicle. Parameters stretch from Kennedy Space Center across and into other program entities (Michaud Assembly Facility, Aliant Techsystems, Stennis Space Center, Johnson Space Center, etc.) though these will only gain detail as the file continues to evolve. The Orion Ares I file definition in the tool continues to evolve, and analysis from this tool is expected in 2008. This is the first application of such business-driven modeling to a NASA/government-- aerospace contractor endeavor.

  2. Modeling solar energetic particle events using ENLIL heliosphere simulations

    NASA Astrophysics Data System (ADS)

    Luhmann, J. G.; Mays, M. L.; Odstrcil, D.; Li, Yan; Bain, H.; Lee, C. O.; Galvin, A. B.; Mewaldt, R. A.; Cohen, C. M. S.; Leske, R. A.; Larson, D.; Futaana, Y.

    2017-07-01

    Solar energetic particle (SEP) event modeling has gained renewed attention in part because of the availability of a decade of multipoint measurements from STEREO and L1 spacecraft at 1 AU. These observations are coupled with improving simulations of the geometry and strength of heliospheric shocks obtained by using coronagraph images to send erupted material into realistic solar wind backgrounds. The STEREO and ACE measurements in particular have highlighted the sometimes surprisingly widespread nature of SEP events. It is thus an opportune time for testing SEP models, which typically focus on protons 1-100 MeV, toward both physical insight to these observations and potentially useful space radiation environment forecasting tools. Some approaches emphasize the concept of particle acceleration and propagation from close to the Sun, while others emphasize the local field line connection to a traveling, evolving shock source. Among the latter is the previously introduced SEPMOD treatment, based on the widely accessible and well-exercised WSA-ENLIL-cone model. SEPMOD produces SEP proton time profiles at any location within the ENLIL domain. Here we demonstrate a SEPMOD version that accommodates multiple, concurrent shock sources occurring over periods of several weeks. The results illustrate the importance of considering longer-duration time periods and multiple CME contributions in analyzing, modeling, and forecasting SEP events.

  3. Introducing stochastics into the simulation of convective precipitation events

    NASA Astrophysics Data System (ADS)

    Pistotnik, Georg

    2010-05-01

    precipitation per time step). Both components of the mean motion as well as of its deviations could be approximated by normal distributions, whereas the number of storms per day, their lifetime, maximum intensity and maximum cell volume roughly followed exponential distributions. The shapes of the convective cells were approximated by Gaussian bells with the peak intensity and the cell volume as boundary conditions. The temporal courses of the peak intensities and cell volumes were assumed to follow parabolas which are symmetric with respect to the half of the lifetime. In the second part of the project, these distributions were used to drive a random generator that allows simulating an arbitrary number of convection days in order to obtain pseudo time series of convective precipitation for each grid point. An algorithm to create correlated samples of random numbers enabled to also account for the observed correlation between some of the parameters, i.e. lifetime and maximum intensity or maximum cell volume. The spatial structures of the return periods of simulated convective precipitation events may provide valuable additional information when being assimilated to the time series measured by the (unfortunately rather sparse) rain gauges in this region. Thus, further studies have to investigate to what extent the "convection simulator" is able to reproduce these time series. Some iterative fine-tuning of the parameters' distributions as well as an extension of the database to a longer time span may further improve the results and enable to simulate realistic spatio-temporal convection scenarios ("design storms") that have the potential to feed hydrological models and, together with vegetation and soil characteristics, hopefully enable to better assess and regionalize the torrent hazard over the project region.

  4. The Number of Patients and Events Required to Limit the Risk of Overestimation of Intervention Effects in Meta-Analysis—A Simulation Study

    PubMed Central

    Thorlund, Kristian; Imberger, Georgina; Walsh, Michael; Chu, Rong; Gluud, Christian; Wetterslev, Jørn; Guyatt, Gordon; Devereaux, Philip J.; Thabane, Lehana

    2011-01-01

    Background Meta-analyses including a limited number of patients and events are prone to yield overestimated intervention effect estimates. While many assume bias is the cause of overestimation, theoretical considerations suggest that random error may be an equal or more frequent cause. The independent impact of random error on meta-analyzed intervention effects has not previously been explored. It has been suggested that surpassing the optimal information size (i.e., the required meta-analysis sample size) provides sufficient protection against overestimation due to random error, but this claim has not yet been validated. Methods We simulated a comprehensive array of meta-analysis scenarios where no intervention effect existed (i.e., relative risk reduction (RRR) = 0%) or where a small but possibly unimportant effect existed (RRR = 10%). We constructed different scenarios by varying the control group risk, the degree of heterogeneity, and the distribution of trial sample sizes. For each scenario, we calculated the probability of observing overestimates of RRR>20% and RRR>30% for each cumulative 500 patients and 50 events. We calculated the cumulative number of patients and events required to reduce the probability of overestimation of intervention effect to 10%, 5%, and 1%. We calculated the optimal information size for each of the simulated scenarios and explored whether meta-analyses that surpassed their optimal information size had sufficient protection against overestimation of intervention effects due to random error. Results The risk of overestimation of intervention effects was usually high when the number of patients and events was small and this risk decreased exponentially over time as the number of patients and events increased. The number of patients and events required to limit the risk of overestimation depended considerably on the underlying simulation settings. Surpassing the optimal information size generally provided sufficient protection

  5. A cable-driven parallel robots application: modelling and simulation of a dynamic cable model in Dymola

    NASA Astrophysics Data System (ADS)

    Othman, M. F.; Kurniawan, R.; Schramm, D.; Ariffin, A. K.

    2018-05-01

    Modeling a cable model in multibody dynamics simulation tool which dynamically varies in length, mass and stiffness is a challenging task. Simulation of cable-driven parallel robots (CDPR) for instance requires a cable model that can dynamically change in length for every desired pose of the platform. Thus, in this paper, a detailed procedure for modeling and simulation of a dynamic cable model in Dymola is proposed. The approach is also applicable for other types of Modelica simulation environments. The cable is modeled using standard mechanical elements like mass, spring, damper and joint. The parameters of the cable model are based on the factsheet of the manufacturer and experimental results. Its dynamic ability is tested by applying it on a complete planar CDPR model in which the parameters are based on a prototype named CABLAR, which is developed in Chair of Mechatronics, University of Duisburg-Essen. The prototype has been developed to demonstrate an application of CDPR as a goods storage and retrieval machine. The performance of the cable model during the simulation is analyzed and discussed.

  6. Towards a General Turbulence Model for Planetary Boundary Layers Based on Direct Statistical Simulation

    NASA Astrophysics Data System (ADS)

    Skitka, J.; Marston, B.; Fox-Kemper, B.

    2016-02-01

    Sub-grid turbulence models for planetary boundary layers are typically constructed additively, starting with local flow properties and including non-local (KPP) or higher order (Mellor-Yamada) parameters until a desired level of predictive capacity is achieved or a manageable threshold of complexity is surpassed. Such approaches are necessarily limited in general circumstances, like global circulation models, by their being optimized for particular flow phenomena. By building a model reductively, starting with the infinite hierarchy of turbulence statistics, truncating at a given order, and stripping degrees of freedom from the flow, we offer the prospect a turbulence model and investigative tool that is equally applicable to all flow types and able to take full advantage of the wealth of nonlocal information in any flow. Direct statistical simulation (DSS) that is based upon expansion in equal-time cumulants can be used to compute flow statistics of arbitrary order. We investigate the feasibility of a second-order closure (CE2) by performing simulations of the ocean boundary layer in a quasi-linear approximation for which CE2 is exact. As oceanographic examples, wind-driven Langmuir turbulence and thermal convection are studied by comparison of the quasi-linear and fully nonlinear statistics. We also characterize the computational advantages and physical uncertainties of CE2 defined on a reduced basis determined via proper orthogonal decomposition (POD) of the flow fields.

  7. Simulation of air admission in a propeller hydroturbine during transient events

    NASA Astrophysics Data System (ADS)

    Nicolle, J.; Morissette, J.-F.

    2016-11-01

    In this study, multiphysic simulations are carried out in order to model fluid loading and structural stresses on propeller blades during startup and runaway. It is found that air admission plays an important role during these transient events and that biphasic simulations are therefore required. At the speed no load regime, a large air pocket with vertical free surface forms in the centre of the runner displacing the water flow near the shroud. This significantly affects the torque developed on the blades and thus structural loading. The resulting pressures are applied to a quasi-static structural model and good agreement is obtained with experimental strain gauge data.

  8. Simulation of networks of spiking neurons: A review of tools and strategies

    PubMed Central

    Brette, Romain; Rudolph, Michelle; Carnevale, Ted; Hines, Michael; Beeman, David; Bower, James M.; Diesmann, Markus; Morrison, Abigail; Goodman, Philip H.; Harris, Frederick C.; Zirpe, Milind; Natschläger, Thomas; Pecevski, Dejan; Ermentrout, Bard; Djurfeldt, Mikael; Lansner, Anders; Rochel, Olivier; Vieville, Thierry; Muller, Eilif; Davison, Andrew P.; El Boustani, Sami

    2009-01-01

    We review different aspects of the simulation of spiking neural networks. We start by reviewing the different types of simulation strategies and algorithms that are currently implemented. We next review the precision of those simulation strategies, in particular in cases where plasticity depends on the exact timing of the spikes. We overview different simulators and simulation environments presently available (restricted to those freely available, open source and documented). For each simulation tool, its advantages and pitfalls are reviewed, with an aim to allow the reader to identify which simulator is appropriate for a given task. Finally, we provide a series of benchmark simulations of different types of networks of spiking neurons, including Hodgkin–Huxley type, integrate-and-fire models, interacting with current-based or conductance-based synapses, using clock-driven or event-driven integration strategies. The same set of models are implemented on the different simulators, and the codes are made available. The ultimate goal of this review is to provide a resource to facilitate identifying the appropriate integration strategy and simulation tool to use for a given modeling problem related to spiking neural networks. PMID:17629781

  9. Episodic Future Thinking in Generalized Anxiety Disorder

    PubMed Central

    Wu, Jade Q.; Szpunar, Karl K.; Godovich, Sheina A.; Schacter, Daniel L.; Hofmann, Stefan G.

    2015-01-01

    Research on future-oriented cognition in generalized anxiety disorder (GAD) has primarily focused on worry, while less is known about the role of episodic future thinking (EFT), an imagery-based cognitive process. To characterize EFT in this disorder, we used the experimental recombination procedure, in which 21 GAD and 19 healthy participants simulated positive, neutral and negative novel future events either once or repeatedly, and rated their phenomenological experience of EFT. Results showed that healthy controls spontaneously generated more detailed EFT over repeated simulations. Both groups found EFT easier to generate after repeated simulations, except when GAD participants simulated positive events. They also perceived higher plausibility of negative—not positive or neutral—future events than did controls. These results demonstrate a negativity bias in GAD individuals’ episodic future cognition, and suggest their relative deficit in generating vivid EFT. We discuss implications for the theory and treatment of GAD. PMID:26398003

  10. Conformity-driven agents support ordered phases in the spatial public goods game

    NASA Astrophysics Data System (ADS)

    Javarone, Marco Alberto; Antonioni, Alberto; Caravelli, Francesco

    2016-05-01

    We investigate the spatial Public Goods Game in the presence of fitness-driven and conformity-driven agents. This framework usually considers only the former type of agents, i.e., agents that tend to imitate the strategy of their fittest neighbors. However, whenever we study social systems, the evolution of a population might be affected also by social behaviors as conformism, stubbornness, altruism, and selfishness. Although the term evolution can assume different meanings depending on the considered domain, here it corresponds to the set of processes that lead a system towards an equilibrium or a steady state. We map fitness to the agents' payoff so that richer agents are those most imitated by fitness-driven agents, while conformity-driven agents tend to imitate the strategy assumed by the majority of their neighbors. Numerical simulations aim to identify the nature of the transition, on varying the amount of the relative density of conformity-driven agents in the population, and to study the nature of related equilibria. Remarkably, we find that conformism generally fosters ordered cooperative phases and may also lead to bistable behaviors.

  11. Simulations of planet migration driven by planetesimal scattering

    NASA Astrophysics Data System (ADS)

    Kirsh, David R.; Duncan, Martin; Brasser, Ramon; Levison, Harold F.

    2009-01-01

    Evidence has mounted for some time that planet migration is an important part of the formation of planetary systems, both in the Solar System [Malhotra, R., 1993. Nature 365, 819-821] and in extrasolar systems [Mayor, M., Queloz, D., 1995. Nature 378, 355-359; Lin, D.N.C., Bodenheimer, P., Richardson, D.C., 1996. Nature 380, 606-607]. One mechanism that produces migration (the change in a planet's semi-major axis a over time) is the scattering of comet- and asteroid-size bodies called planetesimals [Fernandez, J.A., Ip, W.-H., 1984. Icarus 58, 109-120]. Significant angular momentum exchange can occur between the planets and the planetesimals during local scattering, enough to cause a rapid, self-sustained migration of the planet [Ida, S., Bryden, G., Lin, D.N.C., Tanaka, H., 2000. Astrophys. J. 534, 428-445]. This migration has been studied for the particular case of the four outer planets of the Solar System (as in Gomes et al. [Gomes, R.S., Morbidelli, A., Levison, H.F., 2004. Icarus 170, 492-507]), but is not well understood in general. We have used the Miranda [McNeil, D., Duncan, M., Levison, H.F., 2005. Astron. J. 130, 2884-2899] computer simulation code to perform a broad parameter-space survey of the physical variables that determine the migration of a single planet in a planetesimal disk. Migration is found to be predominantly inwards, and the migration rate is found to be independent of planet mass for low-mass planets in relatively high-mass disks. Indeed, a simple scaling relation from Ida et al. [Ida, S., Bryden, G., Lin, D.N.C., Tanaka, H., 2000. Astrophys. J. 534, 428-445] matches well with the dependencies of the migration rate: |{da}/{dt}|=aT{4πΣa/M; with T the orbital period of the planet and Σ the surface density of the planetesimal disk. When the planet's mass exceeds that of the planetesimals within a few Hill radii (the unit of the planet's gravitational reach), the migration rate decreases strongly with planet mass. Other trends are

  12. Symmetry breaking, phase separation and anomalous fluctuations in driven granular gas

    NASA Astrophysics Data System (ADS)

    Meerson, Baruch; Pöschel, Thorsten; Sasorov, Pavel V.; Schwager, Thomas

    2003-03-01

    What is the role of noise, caused by the discrete nature of particles, in granular dynamics? We address this question by considering a simple driven granular system: an ensemble of nearly elastically colliding hard spheres in a rectangular box, driven by a rapidly vibrating side wall at zero gravity. The elementary state of this system is a strip of enhanced particle density away from the driving wall. Granular hydrodynamics (GHD) predicts a symmetry breaking instability of this state, when the aspect ratio of the confining box exceeds a threshold value, while the average density of the gas is within a ``spinodal interval". At large aspect ratios this instability leads to phase separation similar to that in van der Waals gas. In the present work (see cond-mat/0208286) we focus on the system behavior around the threshold of the symmetry-breaking instability. We put GHD into a quantitative test by performing extensive event-driven molecular dynamic simulations in 2D. Please watch the movies of the simulations at http://summa.physik.hu-berlin.de/ kies/HD/. We found that the supercritical bifurcation curve, predicted by GHD, agrees with the simulations well below and well above the instability threshold. In a wide region of aspect ratios around the threshold the system is dominated by fluctuations. We checked that the fluctuation strength goes down when the number of particles increases. However, fluctuations remain strong (and the critical region wide) even for as many as 4 ot 10^4 particles. We conclude by suggesting that fluctuations may put a severe limitation on the validity of continuum theories of granular flow in systems with a moderately large number of particles.

  13. Fast-track extreme event attribution: General methods and techniques to determine the dynamic contribution to an event.

    NASA Astrophysics Data System (ADS)

    Otto, F. E. L.; Haustein, K.; Uhe, P.; Massey, N.; Rimi, R.; Allen, M. R.; Cullen, H. M.

    2016-12-01

    Extreme weather event attribution has become an accepted part of the atmospheric sciences with numerous methods having been put forward over the last decade. We have recently established a new framework which allows for event attribution in quasi-real-time. Here we present the methodology with which we can assess the fraction of attributable risk (FAR) of a severe weather event due to an external driver (Haustein et al. 2016). The method builds on a large ensemble of atmosphere-only GCM simulations forced by seasonal forecast SSTs (actual conditions) that are contrasted with ensembles forced by counterfactual SSTs (natural conditions). Having an associated 30 year actual and natural climatology in place, we are able to put the current event into a climatological context and determine the dynamic contribution that lead to the event as opposed to the thermodynamic contribution which would have made such an event more likely regardless of the synoptic situation. As a second independent method (also applicable in near-real-time), we apply pattern correlation to separate thermodynamic and dynamic contributions. Finally, using reanalysis data, we test whether our attributed dynamic contribution is also detectable in the observations. Despite the high monthly variability, ENSO related teleconnection patterns can be detected fairly robustly as we will demonstrate with a recent example during El Nino. The more consistent the 3 methods are, the more robust our results will be. We note that the choice of time scale matters a lot when determining the dynamic contribution as well as estimating the FAR (Uhe et al. 2016). The weather@home ensemble prediction approach is accompanied by two more methods based on observational data and the CMIP5 ensemble. If the FAR across 3 methods is consistent, we have reason to trust our central attribution statement. Two recent examples will be shown in order to demonstrate the feasibility (van Oldenborgh et al. 2016a/2016b), complemented by

  14. Relative sea-level data from southwest Scotland constrain meltwater-driven sea-level jumps prior to the 8.2 kyr BP event

    NASA Astrophysics Data System (ADS)

    Lawrence, Thomas; Long, Antony J.; Gehrels, W. Roland; Jackson, Luke P.; Smith, David E.

    2016-11-01

    The most significant climate cooling of the Holocene is centred on 8.2 kyr BP (the '8.2 event'). Its cause is widely attributed to an abrupt slowdown of the Atlantic Meridional Overturning Circulation (AMOC) associated with the sudden drainage of Laurentide proglacial Lakes Agassiz and Ojibway, but model simulations have difficulty reproducing the event with a single-pulse scenario of freshwater input. Several lines of evidence point to multiple episodes of freshwater release from the decaying Laurentide Ice Sheet (LIS) between ∼8900 and ∼8200 cal yr BP, yet the precise number, timing and magnitude of these events - critical constraints for AMOC simulations - are far from resolved. Here we present a high-resolution relative sea level (RSL) record for the period 8800 to 7800 cal yr BP developed from estuarine and salt-marsh deposits in SW Scotland. We find that RSL rose abruptly in three steps by 0.35 m, 0.7 m and 0.4 m (mean) at 8760-8640, 8595-8465, 8323-8218 cal yr BP respectively. The timing of these RSL steps correlate closely with short-lived events expressed in North Atlantic proxy climate and oceanographic records, providing evidence of at least three distinct episodes of enhanced meltwater discharge from the decaying LIS prior to the 8.2 event. Our observations can be used to test the fidelity of both climate and ice-sheet models in simulating abrupt change during the early Holocene.

  15. Identification of coronal heating events in 3D simulations

    NASA Astrophysics Data System (ADS)

    Kanella, Charalambos; Gudiksen, Boris V.

    2017-07-01

    Context. The solar coronal heating problem has been an open question in the science community since 1939. One of the proposed models for the transport and release of mechanical energy generated in the sub-photospheric layers and photosphere is the magnetic reconnection model that incorporates Ohmic heating, which releases a part of the energy stored in the magnetic field. In this model many unresolved flaring events occur in the solar corona, releasing enough energy to heat the corona. Aims: The problem with the verification and quantification of this model is that we cannot resolve small scale events due to limitations of the current observational instrumentation. Flaring events have scaling behavior extending from large X-class flares down to the so far unobserved nanoflares. Histograms of observable characteristics of flares show powerlaw behavior for energy release rate, size, and total energy. Depending on the powerlaw index of the energy release, nanoflares might be an important candidate for coronal heating; we seek to find that index. Methods: In this paper we employ a numerical three-dimensional (3D)-magnetohydrodynamic (MHD) simulation produced by the numerical code Bifrost, which enables us to look into smaller structures, and a new technique to identify the 3D heating events at a specific instant. The quantity we explore is the Joule heating, a term calculated directly by the code, which is explicitly correlated with the magnetic reconnection because it depends on the curl of the magnetic field. Results: We are able to identify 4136 events in a volume 24 × 24 × 9.5 Mm3 (I.e., 768 × 786 × 331 grid cells) of a specific snapshot. We find a powerlaw slope of the released energy per second equal to αP = 1.5 ± 0.02, and two powerlaw slopes of the identified volume equal to αV = 1.53 ± 0.03 and αV = 2.53 ± 0.22. The identified energy events do not represent all the released energy, but of the identified events, the total energy of the largest events

  16. Asymptotic Dynamics of Self-driven Vehicles in a Closed Boundary

    NASA Astrophysics Data System (ADS)

    Lee, Chi-Lun; Huang, Chia-Ling

    2011-08-01

    We study the asymptotic dynamics of self-driven vehicles in a loop using a car-following model with the consideration of volume exclusions. In particular, we derive the dynamical steady states for the single-cluster case and obtain the corresponding fundamental diagrams, exhibiting two branches representative of entering and leaving the jam, respectively. By simulations we find that the speed average over all vehicles eventually reaches the same value, regardless of final clustering states. The autocorrelation functions for overall speed average and single-vehicle speed are studied, each revealing a unique time scale. We also discuss the role of noises in vehicular accelerations. Based on our observations we give trial definitions about the degree of chaoticity for general self-driven many-body systems.

  17. RAS Initiative - Events

    Cancer.gov

    The NCI RAS Initiative has organized multiple events with outside experts to discuss how the latest scientific and technological breakthroughs can be applied to discover vulnerabilities in RAS-driven cancers.

  18. Simulation of rainfall-runoff for major flash flood events in Karachi

    NASA Astrophysics Data System (ADS)

    Zafar, Sumaira

    2016-07-01

    Metropolitan city Karachi has strategic importance for Pakistan. With the each passing decade the city is facing urban sprawl and rapid population growth. These rapid changes directly affecting the natural resources of city including its drainage pattern. Karachi has three major cities Malir River with the catchment area of 2252 sqkm and Lyari River has catchment area about 470.4 sqkm. These are non-perennial rivers and active only during storms. Change of natural surfaces into hard pavement causing an increase in rainfall-runoff response. Curve Number is increased which is now causing flash floods in the urban locality of Karachi. There is only one gauge installed on the upstream of the river but there no record for the discharge. Only one gauge located at the upstream is not sufficient for discharge measurements. To simulate the maximum discharge of Malir River rainfall (1985 to 2014) data were collected from Pakistan meteorological department. Major rainfall events use to simulate the rainfall runoff. Maximum rainfall-runoff response was recorded in during 1994, 2007 and 2013. This runoff causes damages and inundation in floodplain areas of Karachi. These flash flooding events not only damage the property but also cause losses of lives

  19. Data-Driven Correlation Analysis Between Observed 3D Fatigue-Crack Path and Computed Fields from High-Fidelity, Crystal-Plasticity, Finite-Element Simulations

    NASA Astrophysics Data System (ADS)

    Pierson, Kyle D.; Hochhalter, Jacob D.; Spear, Ashley D.

    2018-05-01

    Systematic correlation analysis was performed between simulated micromechanical fields in an uncracked polycrystal and the known path of an eventual fatigue-crack surface based on experimental observation. Concurrent multiscale finite-element simulation of cyclic loading was performed using a high-fidelity representation of grain structure obtained from near-field high-energy x-ray diffraction microscopy measurements. An algorithm was developed to parameterize and systematically correlate the three-dimensional (3D) micromechanical fields from simulation with the 3D fatigue-failure surface from experiment. For comparison, correlation coefficients were also computed between the micromechanical fields and hypothetical, alternative surfaces. The correlation of the fields with hypothetical surfaces was found to be consistently weaker than that with the known crack surface, suggesting that the micromechanical fields of the cyclically loaded, uncracked microstructure might provide some degree of predictiveness for microstructurally small fatigue-crack paths, although the extent of such predictiveness remains to be tested. In general, gradients of the field variables exhibit stronger correlations with crack path than the field variables themselves. Results from the data-driven approach implemented here can be leveraged in future model development for prediction of fatigue-failure surfaces (for example, to facilitate univariate feature selection required by convolution-based models).

  20. Extreme weather events and infectious disease outbreaks.

    PubMed

    McMichael, Anthony J

    2015-01-01

    Human-driven climatic changes will fundamentally influence patterns of human health, including infectious disease clusters and epidemics following extreme weather events. Extreme weather events are projected to increase further with the advance of human-driven climate change. Both recent and historical experiences indicate that infectious disease outbreaks very often follow extreme weather events, as microbes, vectors and reservoir animal hosts exploit the disrupted social and environmental conditions of extreme weather events. This review article examines infectious disease risks associated with extreme weather events; it draws on recent experiences including Hurricane Katrina in 2005 and the 2010 Pakistan mega-floods, and historical examples from previous centuries of epidemics and 'pestilence' associated with extreme weather disasters and climatic changes. A fuller understanding of climatic change, the precursors and triggers of extreme weather events and health consequences is needed in order to anticipate and respond to the infectious disease risks associated with human-driven climate change. Post-event risks to human health can be constrained, nonetheless, by reducing background rates of persistent infection, preparatory action such as coordinated disease surveillance and vaccination coverage, and strengthened disaster response. In the face of changing climate and weather conditions, it is critically important to think in ecological terms about the determinants of health, disease and death in human populations.

  1. Dynamics of gas-driven eruptions: Experimental simulations using CO2-H2O-polymer system

    NASA Astrophysics Data System (ADS)

    Zhang, Youxue; Sturtevant, B.; Stolper, E. M.

    1997-02-01

    We report exploratory experiments simulating gas-driven eruptions using the CO2-H2O system at room temperature as an analog of natural eruptive systems. The experimental apparatus consists of a test cell and a large tank. Initially, up to 1.0 wt% of CO2 is dissolved in liquid water under a pressure of up to 735 kPa in the test cell. The experiment is initiated by suddenly reducing the pressure of the test cell to a typical tank pressure of 10 kPa. The following are the main results: (1) The style of the process depends on the decompression ratio. There is a threshold decompression ratio above which rapid eruption occurs. (2) During rapid eruption, there is always fragmentation at the liquid-vapor interface. Fragmentation may also occur in the flow interior. (3) Initially, the top of the erupting column ascends at a constant acceleration (instead of constant velocity). (4) Average bubble radius grows as t2/3. (5) When viscosity is 20 times that of pure water or greater, a static foam may be stable after expansion to 97% vesicularity. The experiments provide several insights into natural gas-driven eruptions, including (1) the interplay between bubble growth and ascent of the erupting column must be considered for realistic modeling of bubble growth during gas-driven eruptions, (2) buoyant rise of the bubbly magma is not necessary during an explosive volcanic eruption, and (3) CO2-driven limnic eruptions can be explosive. The violence increases with the initial CO2 content dissolved in water.

  2. Radial Diffusion study of the 1 June 2013 CME event using MHD simulations.

    NASA Astrophysics Data System (ADS)

    Patel, M.; Hudson, M.; Wiltberger, M. J.; Li, Z.; Boyd, A. J.

    2016-12-01

    The June 1, 2013 storm was a CME-shock driven geomagnetic storm (Dst = -119 nT) that caused a dropout affecting all radiation belt electron energies measured by the Energetic Particle, Composition and Thermal Plasma Suite (ECT) instrument on Van Allen Probes at higher L-shells following dynamic pressure enhancement in the solar wind. Lower energies (up to about 700 keV) were enhanced by the storm while MeV electrons were depleted throughout the belt. We focus on depletion through radial diffusion caused by the enhanced ULF wave activity due to the CME-shock. This study utilities the Lyon-Fedder-Mobarry (LFM) model, a 3D global magnetospheric simulation code based on the ideal MHD equations, coupled with the Magnetosphere Ionosphere Coupler (MIX) and Rice Convection Model (RCM). The MHD electric and magnetic fields with equations described by Fei et al. [JGR, 2006] are used to calculate radial diffusion coefficients (DLL). These DLL values are input into a radial diffusion code to recreate the dropouts observed by the Van Allen Probes. The importance of understanding the complex role that ULF waves play in radial transport and the effects of CME-driven storms on the relativistic energy electrons in the radiation belts can be accomplished using MHD simulations to obtain diffusion coefficients, initial phase space density and the outer boundary condition from the ECT instrument suite and a radial diffusion model to reproduce observed fluxes which compare favorably with Van Allen Probes ECT measurements.

  3. Hierarchical Engine for Large-scale Infrastructure Co-Simulation

    DOE Office of Scientific and Technical Information (OSTI.GOV)

    2017-04-24

    HELICS is designed to support very-large-scale (100,000+ federates) cosimulations with off-the-shelf power-system, communication, market, and end-use tools. Other key features include cross platform operating system support, the integration of both event driven (e.g., packetized communication) and time-series (e.g., power flow) simulations, and the ability to co-iterate among federates to ensure physical model convergence at each time step.

  4. Generalized Fluid System Simulation Program (GFSSP) Version 6 - General Purpose Thermo-Fluid Network Analysis Software

    NASA Technical Reports Server (NTRS)

    Majumdar, Alok; Leclair, Andre; Moore, Ric; Schallhorn, Paul

    2011-01-01

    GFSSP stands for Generalized Fluid System Simulation Program. It is a general-purpose computer program to compute pressure, temperature and flow distribution in a flow network. GFSSP calculates pressure, temperature, and concentrations at nodes and calculates flow rates through branches. It was primarily developed to analyze Internal Flow Analysis of a Turbopump Transient Flow Analysis of a Propulsion System. GFSSP development started in 1994 with an objective to provide a generalized and easy to use flow analysis tool for thermo-fluid systems.

  5. [Adverse events in general and digestive surgery departments in Spanish hospitals].

    PubMed

    Aranaz-Andrés, Jesús M; Ruiz-López, Pedro; Aibar-Remón, Carlos; Requena-Puche, Juana; Agra-Varela, Yolanda; Limón-Ramírez, Ramón; Gea-Velázquez de Castro, María Teresa; Miralles-Bueno, Juan José; Júdez-Legaristi, Diego

    2007-11-01

    To determine the incidence of patients with adverse events (AE) in Spanish general surgery units, describe the immediate causes of AE, identify avoidable AE, and determine the impact of these events. We performed a retrospective cohort study of a randomized stratified sample of 24 hospitals. Six of the hospitals were small (fewer than 200 beds), 13 were medium-sized (between 200 and 499 beds) and five were large (500 or more beds). Patients admitted for more than 24 hours to the selected hospitals and who were discharged between the 4th and 10th of June 2005 were included. AE detected during hospitalization and those occurring as a consequence of previous admissions in the same hospital were analyzed. The incidence of patients with AE associated with medical care was 10.5% (76/735; 95%CI: 8.1%-12.5%). The presence of intrinsic risk factors increased the risk of AE (14.8% vs 7.2%; P=.001). Likewise, 16.2% of patients with an extrinsic risk factor had an AE compared with 7.0% of those without these risk factors (P< .001). Comorbidity influenced the occurrence of AE (33.7% of AE vs. 2.2% without comorbidity; P< .001). The severity of the AE was related to ASA risk (P=.036). AE were related to nosocomial infection (41.7%), procedures (27.1%) and medication (24%). A total of 31.3% of the AE were mild, 39.6% were moderate, and 29.2% were severe. Preventable AE accounted for 36.5%. AE caused an additional 527 days of stay (6.3 additional days of stay per patient), of which 216 were due to preventable AE. Patients in general and digestive surgery units have an increased risk of AE. Risk factors for these events are age, comorbidity, and the use of external devices. A substantial number of AE are related to nosocomial infection (especially surgical wound infection) and to surgical procedures. AE have an important impact on patients and a considerable proportion of these events are preventable. AE have strong health, social and economic repercussions and until recently have

  6. A generalized weight-based particle-in-cell simulation scheme

    NASA Astrophysics Data System (ADS)

    Lee, W. W.; Jenkins, T. G.; Ethier, S.

    2011-03-01

    A generalized weight-based particle simulation scheme suitable for simulating magnetized plasmas, where the zeroth-order inhomogeneity is important, is presented. The scheme is an extension of the perturbative simulation schemes developed earlier for particle-in-cell (PIC) simulations. The new scheme is designed to simulate both the perturbed distribution ( δf) and the full distribution (full- F) within the same code. The development is based on the concept of multiscale expansion, which separates the scale lengths of the background inhomogeneity from those associated with the perturbed distributions. The potential advantage for such an arrangement is to minimize the particle noise by using δf in the linear stage of the simulation, while retaining the flexibility of a full- F capability in the fully nonlinear stage of the development when signals associated with plasma turbulence are at a much higher level than those from the intrinsic particle noise.

  7. General simulation algorithm for autocorrelated binary processes.

    PubMed

    Serinaldi, Francesco; Lombardo, Federico

    2017-02-01

    The apparent ubiquity of binary random processes in physics and many other fields has attracted considerable attention from the modeling community. However, generation of binary sequences with prescribed autocorrelation is a challenging task owing to the discrete nature of the marginal distributions, which makes the application of classical spectral techniques problematic. We show that such methods can effectively be used if we focus on the parent continuous process of beta distributed transition probabilities rather than on the target binary process. This change of paradigm results in a simulation procedure effectively embedding a spectrum-based iterative amplitude-adjusted Fourier transform method devised for continuous processes. The proposed algorithm is fully general, requires minimal assumptions, and can easily simulate binary signals with power-law and exponentially decaying autocorrelation functions corresponding, for instance, to Hurst-Kolmogorov and Markov processes. An application to rainfall intermittency shows that the proposed algorithm can also simulate surrogate data preserving the empirical autocorrelation.

  8. Simulation of Top Quark Pair Production as a Background for Higgs Events at the Compact Muon Solenoid

    NASA Astrophysics Data System (ADS)

    Justus, Christopher

    2005-04-01

    In this study, we simulated top-antitop (tt-bar) quark events at the Compact Muon Solenoid (CMS), an experiment presently being constructed at the Large Hadron Collider in Geneva, Switzerland. The tt-bar process is an important background for Higgs events. We used a chain of software to simulate and reconstruct processes that will occur inside the detector. CMKIN was used to generate and store Monte Carlo Events. OSCAR, a GEANT4 based CMS detector simulator, was used to simulate the CMS detector and how particles would interact with the detector. Next, we used ORCA to simulate the response of the readout electronics at CMS. Last, we used the Jet/MET Root maker to create root files of jets and missing energy. We are now using this software analysis chain to complete a systematic study of initial state radiation at hadron colliders. This study is essential because tt-bar is the main background for the Higgs boson and these processes are extremely sensitive to initial state radiation. Results of our initial state radiation study will be presented. We started this study at the new LHC Physics Center (LPC) located at Fermi National Accelerator Laboratory, and we are now completing the study at the University of Rochester.

  9. Crash avoidance in response to challenging driving events: The roles of age, serialization, and driving simulator platform.

    PubMed

    Bélanger, Alexandre; Gagnon, Sylvain; Stinchcombe, Arne

    2015-09-01

    We examined the crash avoidance behaviors of older and middle-aged drivers in reaction to six simulated challenging road events using two different driving simulator platforms. Thirty-five healthy adults aged 21-36 years old (M=28.9±3.96) and 35 healthy adults aged 65-83 years old (M=72.1±4.34) were tested using a mid-level simulator, and 27 adults aged 21-38 years old (M=28.6±6.63) and 27 healthy adults aged 65-83 years old (M=72.7±5.39) were tested on a low-cost desktop simulator. Participants completed a set of six challenging events varying in terms of the maneuvers required, avoiding space given, directional avoidance cues, and time pressure. Results indicated that older drivers showed higher crash risk when events required multiple synchronized reactions. In situations that required simultaneous use of steering and braking, older adults tended to crash significantly more frequently. As for middle-aged drivers, their crashes were attributable to faster driving speed. The same age-related driving patterns were observed across simulator platforms. Our findings support the hypothesis that older adults tend to react serially while engaging in cognitively challenging road maneuvers. Copyright © 2015 Elsevier Ltd. All rights reserved.

  10. Innovation of IT metasystems by means of event-driven paradigm using QDMS

    NASA Astrophysics Data System (ADS)

    Nedic, Vladimir; Despotovic, Danijela; Cvetanovic, Slobodan; Despotovic, Milan; Eric, Milan

    2016-10-01

    Globalisation of world economy brings new and more complex demands to business systems. In order to respond to these trends, business systems apply new paradigms that are inevitable reflecting on management metasystems - quality assurance (QA), as well as on information technology (IT) metasystems. Small and medium enterprises (in particular in food industry) do not have possibilities to access external resources to the extent that could provide adequate keeping up with these trends. That raises the question how to enhance synergetic effect of interaction between existing QA and IT metasystems in order to overcome resource gap and achieve set goals by internal resources. The focus of this article is to propose a methodology for utilisation of potential of quality assurance document management system (QDMS) as prototypical platform for initiating, developing, testing and improving new functionalities that are required by IT as support for buiness system management. In that way QDMS plays a role of catalyst that not only accelerates but could also enhance selectivity of the reactions of QA and IT metasystems and direct them on finding new functionalities based on event-driven paradigm. The article tries to show the process of modelling, development and implementation of a possible approach to this problem through conceptual survey and practical solution in the food industry.

  11. Detection and Attribution of Simulated Climatic Extreme Events and Impacts: High Sensitivity to Bias Correction

    NASA Astrophysics Data System (ADS)

    Sippel, S.; Otto, F. E. L.; Forkel, M.; Allen, M. R.; Guillod, B. P.; Heimann, M.; Reichstein, M.; Seneviratne, S. I.; Kirsten, T.; Mahecha, M. D.

    2015-12-01

    Understanding, quantifying and attributing the impacts of climatic extreme events and variability is crucial for societal adaptation in a changing climate. However, climate model simulations generated for this purpose typically exhibit pronounced biases in their output that hinders any straightforward assessment of impacts. To overcome this issue, various bias correction strategies are routinely used to alleviate climate model deficiencies most of which have been criticized for physical inconsistency and the non-preservation of the multivariate correlation structure. We assess how biases and their correction affect the quantification and attribution of simulated extremes and variability in i) climatological variables and ii) impacts on ecosystem functioning as simulated by a terrestrial biosphere model. Our study demonstrates that assessments of simulated climatic extreme events and impacts in the terrestrial biosphere are highly sensitive to bias correction schemes with major implications for the detection and attribution of these events. We introduce a novel ensemble-based resampling scheme based on a large regional climate model ensemble generated by the distributed weather@home setup[1], which fully preserves the physical consistency and multivariate correlation structure of the model output. We use extreme value statistics to show that this procedure considerably improves the representation of climatic extremes and variability. Subsequently, biosphere-atmosphere carbon fluxes are simulated using a terrestrial ecosystem model (LPJ-GSI) to further demonstrate the sensitivity of ecosystem impacts to the methodology of bias correcting climate model output. We find that uncertainties arising from bias correction schemes are comparable in magnitude to model structural and parameter uncertainties. The present study consists of a first attempt to alleviate climate model biases in a physically consistent way and demonstrates that this yields improved simulations of

  12. Capacity planning for maternal-fetal medicine using discrete event simulation.

    PubMed

    Ferraro, Nicole M; Reamer, Courtney B; Reynolds, Thomas A; Howell, Lori J; Moldenhauer, Julie S; Day, Theodore Eugene

    2015-07-01

    Maternal-fetal medicine is a rapidly growing field requiring collaboration from many subspecialties. We provide an evidence-based estimate of capacity needs for our clinic, as well as demonstrate how simulation can aid in capacity planning in similar environments. A Discrete Event Simulation of the Center for Fetal Diagnosis and Treatment and Special Delivery Unit at The Children's Hospital of Philadelphia was designed and validated. This model was then used to determine the time until demand overwhelms inpatient bed availability under increasing capacity. No significant deviation was found between historical inpatient censuses and simulated censuses for the validation phase (p = 0.889). Prospectively increasing capacity was found to delay time to balk (the inability of the center to provide bed space for a patient in need of admission). With current capacity, the model predicts mean time to balk of 276 days. Adding three beds delays mean time to first balk to 762 days; an additional six beds to 1,335 days. Providing sufficient access is a patient safety issue, and good planning is crucial for targeting infrastructure investments appropriately. Computer-simulated analysis can provide an evidence base for both medical and administrative decision making in a complex clinical environment. Thieme Medical Publishers 333 Seventh Avenue, New York, NY 10001, USA.

  13. Type 2 solar radio events observed in the interplanetary medium. Part 1: General characteristics

    NASA Technical Reports Server (NTRS)

    Cane, H. V.; Stone, R. G.; Fainberg, J.; Steinberg, J. L.; Hoang, S.

    1980-01-01

    Twelve type 2 solar radio events were observed in the 2 MHz to 30 kHz frequency range by the radio astronomy experiment on the ISEE-3 satellite over the period from September 1978 to December 1979. These data provide the most comprehensive sample of type 2 radio bursts observed at kilometer wavelengths. Dynamic spectra of a number of events are presented. Where possible, the 12 events were associated with an initiating flare, ground based radio data, the passage of a shock at the spacecraft, and the sudden commencement of a geomagnetic storm. The general characteristics of kilometric type 2 bursts are discussed.

  14. Simulating Flying Insects Using Dynamics and Data-Driven Noise Modeling to Generate Diverse Collective Behaviors

    PubMed Central

    Ren, Jiaping; Wang, Xinjie; Manocha, Dinesh

    2016-01-01

    We present a biologically plausible dynamics model to simulate swarms of flying insects. Our formulation, which is based on biological conclusions and experimental observations, is designed to simulate large insect swarms of varying densities. We use a force-based model that captures different interactions between the insects and the environment and computes collision-free trajectories for each individual insect. Furthermore, we model the noise as a constructive force at the collective level and present a technique to generate noise-induced insect movements in a large swarm that are similar to those observed in real-world trajectories. We use a data-driven formulation that is based on pre-recorded insect trajectories. We also present a novel evaluation metric and a statistical validation approach that takes into account various characteristics of insect motions. In practice, the combination of Curl noise function with our dynamics model is used to generate realistic swarm simulations and emergent behaviors. We highlight its performance for simulating large flying swarms of midges, fruit fly, locusts and moths and demonstrate many collective behaviors, including aggregation, migration, phase transition, and escape responses. PMID:27187068

  15. CHARYBDIS: a black hole event generator

    NASA Astrophysics Data System (ADS)

    Harris, Christopher M.; Richardson, Peter; Webber, Bryan R.

    2003-08-01

    CHARYBDIS is an event generator which simulates the production and decay of miniature black holes at hadronic colliders as might be possible in certain extra dimension models. It interfaces via the Les Houches accord to general purpose Monte Carlo programs like HERWIG and PYTHIA which then perform the parton evolution and hadronization. The event generator includes the extra-dimensional `grey-body' effects as well as the change in the temperature of the black hole as the decay progresses. Various options for modelling the Planck-scale terminal decay are provided.

  16. Monte Carlo generator ELRADGEN 2.0 for simulation of radiative events in elastic ep-scattering of polarized particles

    NASA Astrophysics Data System (ADS)

    Akushevich, I.; Filoti, O. F.; Ilyichev, A.; Shumeiko, N.

    2012-07-01

    The structure and algorithms of the Monte Carlo generator ELRADGEN 2.0 designed to simulate radiative events in polarized ep-scattering are presented. The full set of analytical expressions for the QED radiative corrections is presented and discussed in detail. Algorithmic improvements implemented to provide faster simulation of hard real photon events are described. Numerical tests show high quality of generation of photonic variables and radiatively corrected cross section. The comparison of the elastic radiative tail simulated within the kinematical conditions of the BLAST experiment at MIT BATES shows a good agreement with experimental data. Catalogue identifier: AELO_v1_0 Program summary URL:http://cpc.cs.qub.ac.uk/summaries/AELO_v1_0.html Program obtainable from: CPC Program Library, Queen's University, Belfast, N. Ireland Licensing provisions: Standard CPC license, http://cpc.cs.qub.ac.uk/licence/licence.html No. of lines in distributed program, including test data, etc.: 1299 No. of bytes in distributed program, including test data, etc.: 11 348 Distribution format: tar.gz Programming language: FORTRAN 77 Computer: All Operating system: Any RAM: 1 MB Classification: 11.2, 11.4 Nature of problem: Simulation of radiative events in polarized ep-scattering. Solution method: Monte Carlo simulation according to the distributions of the real photon kinematic variables that are calculated by the covariant method of QED radiative correction estimation. The approach provides rather fast and accurate generation. Running time: The simulation of 108 radiative events for itest:=1 takes up to 52 seconds on Pentium(R) Dual-Core 2.00 GHz processor.

  17. Generalized Green's function molecular dynamics for canonical ensemble simulations

    NASA Astrophysics Data System (ADS)

    Coluci, V. R.; Dantas, S. O.; Tewary, V. K.

    2018-05-01

    The need of small integration time steps (˜1 fs) in conventional molecular dynamics simulations is an important issue that inhibits the study of physical, chemical, and biological systems in real timescales. Additionally, to simulate those systems in contact with a thermal bath, thermostating techniques are usually applied. In this work, we generalize the Green's function molecular dynamics technique to allow simulations within the canonical ensemble. By applying this technique to one-dimensional systems, we were able to correctly describe important thermodynamic properties such as the temperature fluctuations, the temperature distribution, and the velocity autocorrelation function. We show that the proposed technique also allows the use of time steps one order of magnitude larger than those typically used in conventional molecular dynamics simulations. We expect that this technique can be used in long-timescale molecular dynamics simulations.

  18. Modeling Temporal Processes in Early Spacecraft Design: Application of Discrete-Event Simulations for Darpa's F6 Program

    NASA Technical Reports Server (NTRS)

    Dubos, Gregory F.; Cornford, Steven

    2012-01-01

    While the ability to model the state of a space system over time is essential during spacecraft operations, the use of time-based simulations remains rare in preliminary design. The absence of the time dimension in most traditional early design tools can however become a hurdle when designing complex systems whose development and operations can be disrupted by various events, such as delays or failures. As the value delivered by a space system is highly affected by such events, exploring the trade space for designs that yield the maximum value calls for the explicit modeling of time.This paper discusses the use of discrete-event models to simulate spacecraft development schedule as well as operational scenarios and on-orbit resources in the presence of uncertainty. It illustrates how such simulations can be utilized to support trade studies, through the example of a tool developed for DARPA's F6 program to assist the design of "fractionated spacecraft".

  19. Quantifying the Contribution of Thermally Driven Recirculation to a High-Ozone Event Along the Colorado Front Range Using Lidar

    NASA Technical Reports Server (NTRS)

    Sullivan, John T.; McGee, Thomas J.; Langford, Andrew O.; Alvarez, Raul J., II; Senff, Christoph; Reddy, Patrick J.; Thompson, Anne M.; Twigg, Laurence W.; Sumnicht, Grant K.; Lee, Pius; hide

    2016-01-01

    A high-ozone (O3) pollution episode was observed on 22 July 2014 during the concurrent Deriving Information on Surface Conditions from Column and Vertically Resolved Observations Relevant to Air Quality (DISCOVER-AQ) and Front Range Air Pollution and Photochemistry Experiment (FRAPPE) campaigns in northern Colorado. Surface O3 monitors at three regulatory sites exceeded the Environmental Protection Agency (EPA) 2008 National Ambient Air Quality Standard (NAAQS) daily maximum 8h average (MDA8) of 75ppbv. To further characterize the polluted air mass and assess transport throughout the event, measurements are presented from O3 and wind profilers, O3-sondes, aircraft, and surface-monitoring sites. Observations indicate that thermally driven upslope flow was established throughout the Colorado Front Range during the pollution episode. As the thermally driven flow persisted throughout the day, O3 concentrations increased and affected high-elevation Rocky Mountain sites. These observations, coupled with modeling analyses, demonstrate a westerly return flow of polluted air aloft, indicating that the mountain-plains solenoid circulation was established and impacted surface conditions within the Front Range.

  20. Improvement of mathematical models for simulation of vehicle handling : volume 7 : technical manual for the general simulation

    DOT National Transportation Integrated Search

    1980-03-01

    This volume is the technical manual for the general simulation. Mathematical modelling of the vehicle and of the human driver is presented in detail, as are differences between the APL simulation and the current one. Information on model validation a...

  1. General Purpose Data-Driven Monitoring for Space Operations

    NASA Technical Reports Server (NTRS)

    Iverson, David L.; Martin, Rodney A.; Schwabacher, Mark A.; Spirkovska, Liljana; Taylor, William McCaa; Castle, Joseph P.; Mackey, Ryan M.

    2009-01-01

    As modern space propulsion and exploration systems improve in capability and efficiency, their designs are becoming increasingly sophisticated and complex. Determining the health state of these systems, using traditional parameter limit checking, model-based, or rule-based methods, is becoming more difficult as the number of sensors and component interactions grow. Data-driven monitoring techniques have been developed to address these issues by analyzing system operations data to automatically characterize normal system behavior. System health can be monitored by comparing real-time operating data with these nominal characterizations, providing detection of anomalous data signatures indicative of system faults or failures. The Inductive Monitoring System (IMS) is a data-driven system health monitoring software tool that has been successfully applied to several aerospace applications. IMS uses a data mining technique called clustering to analyze archived system data and characterize normal interactions between parameters. The scope of IMS based data-driven monitoring applications continues to expand with current development activities. Successful IMS deployment in the International Space Station (ISS) flight control room to monitor ISS attitude control systems has led to applications in other ISS flight control disciplines, such as thermal control. It has also generated interest in data-driven monitoring capability for Constellation, NASA's program to replace the Space Shuttle with new launch vehicles and spacecraft capable of returning astronauts to the moon, and then on to Mars. Several projects are currently underway to evaluate and mature the IMS technology and complementary tools for use in the Constellation program. These include an experiment on board the Air Force TacSat-3 satellite, and ground systems monitoring for NASA's Ares I-X and Ares I launch vehicles. The TacSat-3 Vehicle System Management (TVSM) project is a software experiment to integrate fault

  2. Tutorial in medical decision modeling incorporating waiting lines and queues using discrete event simulation.

    PubMed

    Jahn, Beate; Theurl, Engelbert; Siebert, Uwe; Pfeiffer, Karl-Peter

    2010-01-01

    In most decision-analytic models in health care, it is assumed that there is treatment without delay and availability of all required resources. Therefore, waiting times caused by limited resources and their impact on treatment effects and costs often remain unconsidered. Queuing theory enables mathematical analysis and the derivation of several performance measures of queuing systems. Nevertheless, an analytical approach with closed formulas is not always possible. Therefore, simulation techniques are used to evaluate systems that include queuing or waiting, for example, discrete event simulation. To include queuing in decision-analytic models requires a basic knowledge of queuing theory and of the underlying interrelationships. This tutorial introduces queuing theory. Analysts and decision-makers get an understanding of queue characteristics, modeling features, and its strength. Conceptual issues are covered, but the emphasis is on practical issues like modeling the arrival of patients. The treatment of coronary artery disease with percutaneous coronary intervention including stent placement serves as an illustrative queuing example. Discrete event simulation is applied to explicitly model resource capacities, to incorporate waiting lines and queues in the decision-analytic modeling example.

  3. HIGH-FIDELITY SIMULATION-DRIVEN MODEL DEVELOPMENT FOR COARSE-GRAINED COMPUTATIONAL FLUID DYNAMICS

    DOE Office of Scientific and Technical Information (OSTI.GOV)

    Hanna, Botros N.; Dinh, Nam T.; Bolotnov, Igor A.

    Nuclear reactor safety analysis requires identifying various credible accident scenarios and determining their consequences. For a full-scale nuclear power plant system behavior, it is impossible to obtain sufficient experimental data for a broad range of risk-significant accident scenarios. In single-phase flow convective problems, Direct Numerical Simulation (DNS) and Large Eddy Simulation (LES) can provide us with high fidelity results when physical data are unavailable. However, these methods are computationally expensive and cannot be afforded for simulation of long transient scenarios in nuclear accidents despite extraordinary advances in high performance scientific computing over the past decades. The major issue is themore » inability to make the transient computation parallel, thus making number of time steps required in high-fidelity methods unaffordable for long transients. In this work, we propose to apply a high fidelity simulation-driven approach to model sub-grid scale (SGS) effect in Coarse Grained Computational Fluid Dynamics CG-CFD. This approach aims to develop a statistical surrogate model instead of the deterministic SGS model. We chose to start with a turbulent natural convection case with volumetric heating in a horizontal fluid layer with a rigid, insulated lower boundary and isothermal (cold) upper boundary. This scenario of unstable stratification is relevant to turbulent natural convection in a molten corium pool during a severe nuclear reactor accident, as well as in containment mixing and passive cooling. The presented approach demonstrates how to create a correction for the CG-CFD solution by modifying the energy balance equation. A global correction for the temperature equation proves to achieve a significant improvement to the prediction of steady state temperature distribution through the fluid layer.« less

  4. Clinical utility of the impact of event scale: psychometrics in the general population.

    PubMed

    Briere, J; Elliott, D M

    1998-06-01

    The Impact of Event Scale (IES; Horowitz, Wilner, & Alvarez, 1979), Trauma Symptom Inventory (TSI; Briere, 1995), Los Angeles Symptom Checklist (LASC; Foy, Sipprelle, Rueger, & Carroll, 1984), and Traumatic Events Survey (TES; Elliott, 1992) were administered to a sample of 505 participants from the general population. In this application of the IES, participants reported on "an upsetting event," as opposed to a specific stressor. The IES was found to be reliable and to have concurrent validity with respect to the TSI and LASC. IES scores varied as a function of race, but this relationship disappeared once race differences in exposure to potentially traumatic events (PTEs) were taken into account. Although the IES was predictive of PTEs, the traumatic stress scales of the TSI had more predictive and incremental validity than the IES. The current data suggest that an "upsetting event" version of the IES may be useful as a brief screen for nonarousal-related posttraumatic stress, but that its potential limitations should be taken into account. Normative data on this version of the IES are presented.

  5. Magnetic Flyer Facility Correlation and UGT Simulation

    DTIC Science & Technology

    1978-05-01

    AND UGT SIMULATION (U) Kaman Sciences Corporation L ~ P.O. Box 7463 I Colorado Springs, Colcerado 80933 ý4 May 1978DC Final Report CONTRACT No. DNA O01...selected underground test ( UGT ) environment on 3DQP; and, (2) To correlate the magnetically driven flyer plate facilities of VKSC with those of the...tailored to matcb the pressure vs. time anid total impulse measurements obtained on UGT events. This matching of experi- mental data required considerable

  6. Classical and generalized Horton laws for peak flows in rainfall-runoff events.

    PubMed

    Gupta, Vijay K; Ayalew, Tibebu B; Mantilla, Ricardo; Krajewski, Witold F

    2015-07-01

    The discovery of the Horton laws for hydrologic variables has greatly lagged behind geomorphology, which began with Robert Horton in 1945. We define the classical and the generalized Horton laws for peak flows in rainfall-runoff events, which link self-similarity in network geomorphology with river basin hydrology. Both the Horton laws are tested in the Iowa River basin in eastern Iowa that drains an area of approximately 32 400 km(2) before it joins the Mississippi River. The US Geological Survey continuously monitors the basin through 34 stream gauging stations. We select 51 rainfall-runoff events for carrying out the tests. Our findings support the existence of the classical and the generalized Horton laws for peak flows, which may be considered as a new hydrologic discovery. Three different methods are illustrated for estimating the Horton peak-flow ratio due to small sample size issues in peak flow data. We illustrate an application of the Horton laws for diagnosing parameterizations in a physical rainfall-runoff model. The ideas and developments presented here offer exciting new directions for hydrologic research and education.

  7. Pesticide trapping efficiency of a modified backwater wetland using a simulated runoff event

    USDA-ARS?s Scientific Manuscript database

    This study examined the trapping efficiency of a modified backwater wetland amended with a mixture of three pesticides, atrazine, metolachlor, and fipronil, using a simulated runoff event. The 700 m long, 25 m wide wetland, located along the Coldwater River in Tunica County, Mississippi, was modifie...

  8. Recovery process and determinants of adverse event occurrence in bronchoscopic procedures performed under general anaesthesia.

    PubMed

    Özden Omaygenç, Derya; Ünal, Nermin; Edipoğlu, Saadet İpek; Barca Şeker, Tuğçe; Özgül, Mehmet Akif; Turan, Demet; Özdemir, Cengiz; Karaca, İbrahim Oğuz; Çetinkaya, Erdoğan

    2018-04-16

    Regarding the fact that rigid bronchoscopy is generally performed under general anaesthesia and this patient subgroup is remarkably morbid, encountering procedure and/or anaesthesia related complications are highly likely. Here, we aimed to assess factors influencing recovery and detect possible determinants of adverse event occurrence during these operations performed in a tertiary referral centre. Eighty-one consecutive ASA I-IV patients were recruited for this investigation. In the operating theatre after induction of anaesthesia and advancement of the device, maintenance was provided with total intravenous anaesthesia. Neuromuscular blockage was invariably administered, and patients were ventilated manually. In addition to preoperative demographic and procedural characteristics, perioperative hemodynamic variables, recovery times and observed adverse events were noted. Basic demographic properties, ASA and Mallampati scores, and procedure specific variables as lesion localization, lesion and procedure type were comparable among groups assembled with reference to event occurrence. Patients who had experienced adverse event had higher heart rates. Recovery times were comparable between Event (-) and Event (+) groups. Relationship of recovery process were individually tested with all variables and only lesion type was detected to have an effect on respiration and extubation times. Among all parameters only procedural time seemed to be associated with adverse event occurrence (mins, 22.9 ± 11.9 vs 41.6 ± 28.8, P < .001). Recovery times related with return of spontaneous respiration were significantly lower in procedures performed for treatment of tumoral diseases in this study and procedure length was determined to be the ultimate factor which had an impact on adverse event occurrence. © 2018 John Wiley & Sons Ltd.

  9. Development of simulation approach for two-dimensional chiral molecular self-assembly driven by hydrogen bond at the liquid/solid interface

    NASA Astrophysics Data System (ADS)

    Qin, Yuan; Yao, Man; Hao, Ce; Wan, Lijun; Wang, Yunhe; Chen, Ting; Wang, Dong; Wang, Xudong; Chen, Yonggang

    2017-09-01

    Two-dimensional (2D) chiral self-assembly system of 5-(benzyloxy)-isophthalic acid derivative/(S)-(+)-2-octanol/highly oriented pyrolytic graphite was studied. A combined density functional theory/molecular mechanics/molecular dynamics (DFT/MM/MD) approach for system of 2D chiral molecular self-assembly driven by hydrogen bond at the liquid/solid interface was thus proposed. Structural models of the chiral assembly were built on the basis of scanning tunneling microscopy (STM) images and simplified for DFT geometry optimization. Merck Molecular Force Field (MMFF) was singled out as the suitable force field by comparing the optimized configurations of MM and DFT. MM and MD simulations for hexagonal unit model which better represented the 2D assemble network were then preformed with MMFF. The adhesion energy, evolution of self-assembly process and characteristic parameters of hydrogen bond were obtained and analyzed. According to the above simulation, the stabilities of the clockwise and counterclockwise enantiomorphous networks were evaluated. The calculational results were supported by STM observations and the feasibility of the simulation method was confirmed by two other systems in the presence of chiral co-absorbers (R)-(-)-2-octanol and achiral co-absorbers 1-octanol. This theoretical simulation method assesses the stability trend of 2D enantiomorphous assemblies with atomic scale and can be applied to the similar hydrogen bond driven 2D chirality of molecular self-assembly system.

  10. Towards a Self-Consistent Simulation Capability of Catastrophic Solar Energetic Particle Events

    NASA Astrophysics Data System (ADS)

    Sokolov, I.; Gombosi, T. I.; Bindi, V.; Borovikov, D.; Kota, J.; Giacalone, J.

    2016-12-01

    Space weather refers to variations in the space environment that can affect technologies or endanger human life and health. Solar energetic particle (SEP) events can affect communications and airline safety. Satellites are affected by radiation damage to electronics and to components that produce power and provide images. Sun and star sensors are blinded during large SEP events. Protons of ≳30 MeV penetrate spacesuits and spacecraft walls. Events, like that of August 4, 1972, would have been fatal to moon-walking astronauts. Catastrophic events typically are characterized by hard particle energy spectra potentially containing large fluxes of hundreds of MeV-GeV type particles. These super-energetic particles can penetrate even into the "safest" areas of spacecraft and produce induced radioactivity. We describe several technologies which are to be combined into a physics-based, self consistent model to understand and forecast the origin and evolution of SEP events: The Alfvén Wave Solar-wind Model (AWSoM) simulates the chromosphere-to-Earth system using separate electron and ion temperatures and separate parallel and perpendicular temperatures. It solves the energy equations including thermal conduction and coronal heating by Alfvén wave turbulence. It uses adaptive mesh refinement (AMR), which allows us to cover a broad range of spacial scales. The Eruptive Event Generator using the Gibson-Low flux-rope model (EEGGL) allows the user to select an active region on the sun, select the polarity inversion line where the eruption is observed, and insert a Gibson-Low flux-rope to produce eruption. The Multiple-Field-Lines-Advection Model for Particle Acceleration (M-FLAMPA) solves the particle transport equation along a multitude of interplanetary magnetic field lines originating from the Sun, using time-dependent parameters for the shock and magnetic field obtained from the MHD simulation. It includes a self-consistent coupling of Alfvén wave turbulence to the SEPs

  11. Ion Acceleration by Flux Transfer Events in the Terrestrial Magnetosheath

    NASA Astrophysics Data System (ADS)

    Jarvinen, R.; Vainio, R.; Palmroth, M.; Juusola, L.; Hoilijoki, S.; Pfau-Kempf, Y.; Ganse, U.; Turc, L.; von Alfthan, S.

    2018-02-01

    We report ion acceleration by flux transfer events in the terrestrial magnetosheath in a global two-dimensional hybrid-Vlasov polar plane simulation of Earth's solar wind interaction. In the model we find that propagating flux transfer events created in magnetic reconnection at the dayside magnetopause drive fast-mode bow waves in the magnetosheath, which accelerate ions in the shocked solar wind flow. The acceleration at the bow waves is caused by a shock drift-like acceleration process under stationary solar wind and interplanetary magnetic field upstream conditions. Thus, the energization is not externally driven but results from plasma dynamics within the magnetosheath. Energetic proton populations reach the energy of 30 keV, and their velocity distributions resemble time-energy dispersive ion injections observed by the Cluster spacecraft in the magnetosheath.

  12. Modeling the Impact of Stream Discharge Events on Riparian Solute Dynamics.

    PubMed

    Mahmood, Muhammad Nasir; Schmidt, Christian; Fleckenstein, Jan H; Trauth, Nico

    2018-03-22

    The biogeochemical composition of stream water and the surrounding riparian water is mainly defined by the exchange of water and solutes between the stream and the riparian zone. Short-term fluctuations in near stream hydraulic head gradients (e.g., during stream flow events) can significantly influence the extent and rate of exchange processes. In this study, we simulate exchanges between streams and their riparian zone driven by stream stage fluctuations during single stream discharge events of varying peak height and duration. Simulated results show that strong stream flow events can trigger solute mobilization in riparian soils and subsequent export to the stream. The timing and amount of solute export is linked to the shape of the discharge event. Higher peaks and increased durations significantly enhance solute export, however, peak height is found to be the dominant control for overall mass export. Mobilized solutes are transported to the stream in two stages (1) by return flow of stream water that was stored in the riparian zone during the event and (2) by vertical movement to the groundwater under gravity drainage from the unsaturated parts of the riparian zone, which lasts for significantly longer time (> 400 days) resulting in long tailing of bank outflows and solute mass outfluxes. We conclude that strong stream discharge events can mobilize and transport solutes from near stream riparian soils into the stream. The impact of short-term stream discharge variations on solute exchange may last for long times after the flow event. © 2018, National Ground Water Association.

  13. Numerical simulation of hydrodynamic processes beneath a wind-driven water surface

    NASA Astrophysics Data System (ADS)

    Tsai, Wu-ting

    Turbulent flow driven by a constant wind stress acting at the water surface was simulated numerically to gain a better understanding of the hydrodynamic processes governing the transfer of slightly soluble gases across the atmosphere-water interfaces. Simulation results show that two distinct flow features, attributed to subsurface surface renewal eddies, appear at the water surface. The first characteristic feature is surface streaming, which consists of high-speed streaks aligned with the wind stress. Floating Lagrangian particles, which are distributed uniformly at the water surface, merge to the predominantly high-speed streaks and form elongated streets immediately after they are released. The second characteristic surface signatures are localized low-speed spots which emerge randomly at the water surface. A high-speed streak bifurcates and forms a dividing flow when it encounters a low-speed surface spot. These coherent surface flow structures are qualitatively identical to those observed in the experiment of Melville et al. [1998]. The persistence of these surface features also suggests that there must exist organized subsurface vortical structures that undergo autonomous generation cycles maintained by self-sustaining mechanisms. These coherent vortical flows serve as the renewal eddies that pump the submerged fluids toward the water surface and bring down the upper fluids, and therefore enhance the scalar exchange between the atmosphere and the water body.

  14. Budget impact analysis of thrombolysis for stroke in Spain: a discrete event simulation model.

    PubMed

    Mar, Javier; Arrospide, Arantzazu; Comas, Mercè

    2010-01-01

    Thrombolysis within the first 3 hours after the onset of symptoms of a stroke has been shown to be a cost-effective treatment because treated patients are 30% more likely than nontreated patients to have no residual disability. The objective of this study was to calculate by means of a discrete event simulation model the budget impact of thrombolysis in Spain. The budget impact analysis was based on stroke incidence rates and the estimation of the prevalence of stroke-related disability in Spain and its translation to hospital and social costs. A discrete event simulation model was constructed to represent the flow of patients with stroke in Spain. If 10% of patients with stroke from 2000 to 2015 would receive thrombolytic treatment, the prevalence of dependent patients in 2015 would decrease from 149,953 to 145,922. For the first 6 years, the cost of intervention would surpass the savings. Nevertheless, the number of cases in which patient dependency was avoided would steadily increase, and after 2006 the cost savings would be greater, with a widening difference between the cost of intervention and the cost of nonintervention, until 2015. The impact of thrombolysis on society's health and social budget indicates a net benefit after 6 years, and the improvement in health grows continuously. The validation of the model demonstrates the adequacy of the discrete event simulation approach in representing the epidemiology of stroke to calculate the budget impact.

  15. Generalized dynamic engine simulation techniques for the digital computer

    NASA Technical Reports Server (NTRS)

    Sellers, J.; Teren, F.

    1974-01-01

    Recently advanced simulation techniques have been developed for the digital computer and used as the basis for development of a generalized dynamic engine simulation computer program, called DYNGEN. This computer program can analyze the steady state and dynamic performance of many kinds of aircraft gas turbine engines. Without changes to the basic program, DYNGEN can analyze one- or two-spool turbofan engines. The user must supply appropriate component performance maps and design-point information. Examples are presented to illustrate the capabilities of DYNGEN in the steady state and dynamic modes of operation. The analytical techniques used in DYNGEN are briefly discussed, and its accuracy is compared with a comparable simulation using the hybrid computer. The impact of DYNGEN and similar all-digital programs on future engine simulation philosophy is also discussed.

  16. Generalized dynamic engine simulation techniques for the digital computer

    NASA Technical Reports Server (NTRS)

    Sellers, J.; Teren, F.

    1974-01-01

    Recently advanced simulation techniques have been developed for the digital computer and used as the basis for development of a generalized dynamic engine simulation computer program, called DYNGEN. This computer program can analyze the steady state and dynamic performance of many kinds of aircraft gas turbine engines. Without changes to the basic program DYNGEN can analyze one- or two-spool turbofan engines. The user must supply appropriate component performance maps and design-point information. Examples are presented to illustrate the capabilities of DYNGEN in the steady state and dynamic modes of operation. The analytical techniques used in DYNGEN are briefly discussed, and its accuracy is compared with a comparable simulation using the hybrid computer. The impact of DYNGEN and similar all-digital programs on future engine simulation philosophy is also discussed.

  17. Generalized dynamic engine simulation techniques for the digital computers

    NASA Technical Reports Server (NTRS)

    Sellers, J.; Teren, F.

    1975-01-01

    Recently advanced simulation techniques have been developed for the digital computer and used as the basis for development of a generalized dynamic engine simulation computer program, called DYNGEN. This computer program can analyze the steady state and dynamic performance of many kinds of aircraft gas turbine engines. Without changes to the basic program, DYNGEN can analyze one- or two-spool turbofan engines. The user must supply appropriate component performance maps and design point information. Examples are presented to illustrate the capabilities of DYNGEN in the steady state and dynamic modes of operation. The analytical techniques used in DYNGEN are briefly discussed, and its accuracy is compared with a comparable simulation using the hybrid computer. The impact of DYNGEN and similar digital programs on future engine simulation philosophy is also discussed.

  18. Convection- and SASI-driven flows in parametrized models of core-collapse supernova explosions

    DOE PAGES

    Endeve, E.; Cardall, C. Y.; Budiardja, R. D.; ...

    2016-01-21

    We present initial results from three-dimensional simulations of parametrized core-collapse supernova (CCSN) explosions obtained with our astrophysical simulation code General Astrophysical Simulation System (GenASIS). We are interested in nonlinear flows resulting from neutrino-driven convection and the standing accretion shock instability (SASI) in the CCSN environment prior to and during the explosion. By varying parameters in our model that control neutrino heating and shock dissociation, our simulations result in convection-dominated and SASI-dominated evolution. We describe this initial set of simulation results in some detail. To characterize the turbulent flows in the simulations, we compute and compare velocity power spectra from convection-dominatedmore » and SASI-dominated (both non-exploding and exploding) models. When compared to SASI-dominated models, convection-dominated models exhibit significantly more power on small spatial scales.« less

  19. Parallel discrete-event simulation schemes with heterogeneous processing elements.

    PubMed

    Kim, Yup; Kwon, Ikhyun; Chae, Huiseung; Yook, Soon-Hyung

    2014-07-01

    To understand the effects of nonidentical processing elements (PEs) on parallel discrete-event simulation (PDES) schemes, two stochastic growth models, the restricted solid-on-solid (RSOS) model and the Family model, are investigated by simulations. The RSOS model is the model for the PDES scheme governed by the Kardar-Parisi-Zhang equation (KPZ scheme). The Family model is the model for the scheme governed by the Edwards-Wilkinson equation (EW scheme). Two kinds of distributions for nonidentical PEs are considered. In the first kind computing capacities of PEs are not much different, whereas in the second kind the capacities are extremely widespread. The KPZ scheme on the complex networks shows the synchronizability and scalability regardless of the kinds of PEs. The EW scheme never shows the synchronizability for the random configuration of PEs of the first kind. However, by regularizing the arrangement of PEs of the first kind, the EW scheme is made to show the synchronizability. In contrast, EW scheme never shows the synchronizability for any configuration of PEs of the second kind.

  20. The development of an interim generalized gate logic software simulator

    NASA Technical Reports Server (NTRS)

    Mcgough, J. G.; Nemeroff, S.

    1985-01-01

    A proof-of-concept computer program called IGGLOSS (Interim Generalized Gate Logic Software Simulator) was developed and is discussed. The simulator engine was designed to perform stochastic estimation of self test coverage (fault-detection latency times) of digital computers or systems. A major attribute of the IGGLOSS is its high-speed simulation: 9.5 x 1,000,000 gates/cpu sec for nonfaulted circuits and 4.4 x 1,000,000 gates/cpu sec for faulted circuits on a VAX 11/780 host computer.

  1. Simulation of a dust episode over Eastern Mediterranean using a high-resolution atmospheric chemistry general circulation model

    NASA Astrophysics Data System (ADS)

    Abdel Kader, Mohamed; Zittis, Georgios; Astitha, Marina; Lelieveld, Jos; Tymvios, Fillipos

    2013-04-01

    An extended episode of low visibility took place over the Eastern Mediterranean in late September 2011, caused by a strong increase in dust concentrations, analyzed from observations of PM10 (Particulate Matter with <10μm in diameter). A high-resolution version of the atmospheric chemistry general circulation model EMAC (ECHAM5/Messy2.41 Atmospheric Chemistry) was used to simulate the emissions, transport and deposition of airborne desert dust. The model configuration involves the spectral resolution of T255 (0.5°, ~50Km) and 31 vertical levels in the troposphere and lower stratosphere. The model was nudged towards ERA40 reanalysis data to represent the actual meteorological conditions. The dust emissions were calculated online at each model time step and the aerosol microphysics using the GMXe submodel (Global Modal-aerosol eXtension). The model includes a sulphur chemistry mechanism to simulate the transformation of the dust particles from the insoluble (at emission) to soluble modes, which promotes dust removal by precipitation. The model successfully reproduces the dust distribution according to observations by the MODIS satellite instruments and ground-based AERONET stations. The PM10 concentration is also compared with in-situ measurements over Cyprus, resulting in good agreement. The model results show two subsequent dust events originating from the Negev and Sahara deserts. The first dust event resulted from the transport of dust from the Sahara on the 21st of September and lasted only briefly (hours) as the dust particles were efficiently removed by precipitation simulated by the model and observed by the TRMM (Tropical Rainfall Measuring Mission) satellites. The second event resulted from dust transport from the Negev desert to the Eastern Mediterranean during the period 26th - 30th September with a peak concentration at 2500m elevation. This event lasted for four days and diminished due to dry deposition. The observed reduced visibility over Cyprus

  2. Discrete event simulation as a tool in optimization of a professional complex adaptive system.

    PubMed

    Nielsen, Anders Lassen; Hilwig, Helmer; Kissoon, Niranjan; Teelucksingh, Surujpal

    2008-01-01

    Similar urgent needs for improvement of health care systems exist in the developed and developing world. The culture and the organization of an emergency department in developing countries can best be described as a professional complex adaptive system, where each agent (employee) are ignorant of the behavior of the system as a whole; no one understands the entire system. Each agent's action is based on the state of the system at the moment (i.e. lack of medicine, unavailable laboratory investigation, lack of beds and lack of staff in certain functions). An important question is how one can improve the emergency service within the given constraints. The use of simulation signals is one new approach in studying issues amenable to improvement. Discrete event simulation was used to simulate part of the patient flow in an emergency department. A simple model was built using a prototyping approach. The simulation showed that a minor rotation among the nurses could reduce the mean number of visitors that had to be refereed to alternative flows within the hospital from 87 to 37 on a daily basis with a mean utilization of the staff between 95.8% (the nurses) and 87.4% (the doctors). We conclude that even faced with resource constraints and lack of accessible data discrete event simulation is a tool that can be used successfully to study the consequences of changes in very complex and self organizing professional complex adaptive systems.

  3. Soil organic carbon loss and selective transportation under field simulated rainfall events.

    PubMed

    Nie, Xiaodong; Li, Zhongwu; Huang, Jinquan; Huang, Bin; Zhang, Yan; Ma, Wenming; Hu, Yanbiao; Zeng, Guangming

    2014-01-01

    The study on the lateral movement of soil organic carbon (SOC) during soil erosion can improve the understanding of global carbon budget. Simulated rainfall experiments on small field plots were conducted to investigate the SOC lateral movement under different rainfall intensities and tillage practices. Two rainfall intensities (High intensity (HI) and Low intensity (LI)) and two tillage practices (No tillage (NT) and Conventional tillage (CT)) were maintained on three plots (2 m width × 5 m length): HI-NT, LI-NT and LI-CT. The rainfall lasted 60 minutes after the runoff generated, the sediment yield and runoff volume were measured and sampled at 6-min intervals. SOC concentration of sediment and runoff as well as the sediment particle size distribution were measured. The results showed that most of the eroded organic carbon (OC) was lost in form of sediment-bound organic carbon in all events. The amount of lost SOC in LI-NT event was 12.76 times greater than that in LI-CT event, whereas this measure in HI-NT event was 3.25 times greater than that in LI-NT event. These results suggest that conventional tillage as well as lower rainfall intensity can reduce the amount of lost SOC during short-term soil erosion. Meanwhile, the eroded sediment in all events was enriched in OC, and higher enrichment ratio of OC (ERoc) in sediment was observed in LI events than that in HI event, whereas similar ERoc curves were found in LI-CT and LI-NT events. Furthermore, significant correlations between ERoc and different size sediment particles were only observed in HI-NT event. This indicates that the enrichment of OC is dependent on the erosion process, and the specific enrichment mechanisms with respect to different erosion processes should be studied in future.

  4. Soil Organic Carbon Loss and Selective Transportation under Field Simulated Rainfall Events

    PubMed Central

    Nie, Xiaodong; Li, Zhongwu; Huang, Jinquan; Huang, Bin; Zhang, Yan; Ma, Wenming; Hu, Yanbiao; Zeng, Guangming

    2014-01-01

    The study on the lateral movement of soil organic carbon (SOC) during soil erosion can improve the understanding of global carbon budget. Simulated rainfall experiments on small field plots were conducted to investigate the SOC lateral movement under different rainfall intensities and tillage practices. Two rainfall intensities (High intensity (HI) and Low intensity (LI)) and two tillage practices (No tillage (NT) and Conventional tillage (CT)) were maintained on three plots (2 m width × 5 m length): HI-NT, LI-NT and LI-CT. The rainfall lasted 60 minutes after the runoff generated, the sediment yield and runoff volume were measured and sampled at 6-min intervals. SOC concentration of sediment and runoff as well as the sediment particle size distribution were measured. The results showed that most of the eroded organic carbon (OC) was lost in form of sediment-bound organic carbon in all events. The amount of lost SOC in LI-NT event was 12.76 times greater than that in LI-CT event, whereas this measure in HI-NT event was 3.25 times greater than that in LI-NT event. These results suggest that conventional tillage as well as lower rainfall intensity can reduce the amount of lost SOC during short-term soil erosion. Meanwhile, the eroded sediment in all events was enriched in OC, and higher enrichment ratio of OC (ERoc) in sediment was observed in LI events than that in HI event, whereas similar ERoc curves were found in LI-CT and LI-NT events. Furthermore, significant correlations between ERoc and different size sediment particles were only observed in HI-NT event. This indicates that the enrichment of OC is dependent on the erosion process, and the specific enrichment mechanisms with respect to different erosion processes should be studied in future. PMID:25166015

  5. A generalized linear integrate-and-fire neural model produces diverse spiking behaviors.

    PubMed

    Mihalaş, Stefan; Niebur, Ernst

    2009-03-01

    For simulations of neural networks, there is a trade-off between the size of the network that can be simulated and the complexity of the model used for individual neurons. In this study, we describe a generalization of the leaky integrate-and-fire model that produces a wide variety of spiking behaviors while still being analytically solvable between firings. For different parameter values, the model produces spiking or bursting, tonic, phasic or adapting responses, depolarizing or hyperpolarizing after potentials and so forth. The model consists of a diagonalizable set of linear differential equations describing the time evolution of membrane potential, a variable threshold, and an arbitrary number of firing-induced currents. Each of these variables is modified by an update rule when the potential reaches threshold. The variables used are intuitive and have biological significance. The model's rich behavior does not come from the differential equations, which are linear, but rather from complex update rules. This single-neuron model can be implemented using algorithms similar to the standard integrate-and-fire model. It is a natural match with event-driven algorithms for which the firing times are obtained as a solution of a polynomial equation.

  6. A Generalized Linear Integrate-and-Fire Neural Model Produces Diverse Spiking Behaviors

    PubMed Central

    Mihalaş, Ştefan; Niebur, Ernst

    2010-01-01

    For simulations of neural networks, there is a trade-off between the size of the network that can be simulated and the complexity of the model used for individual neurons. In this study, we describe a generalization of the leaky integrate-and-fire model that produces a wide variety of spiking behaviors while still being analytically solvable between firings. For different parameter values, the model produces spiking or bursting, tonic, phasic or adapting responses, depolarizing or hyperpolarizing after potentials and so forth. The model consists of a diagonalizable set of linear differential equations describing the time evolution of membrane potential, a variable threshold, and an arbitrary number of firing-induced currents. Each of these variables is modified by an update rule when the potential reaches threshold. The variables used are intuitive and have biological significance. The model’s rich behavior does not come from the differential equations, which are linear, but rather from complex update rules. This single-neuron model can be implemented using algorithms similar to the standard integrate-and-fire model. It is a natural match with event-driven algorithms for which the firing times are obtained as a solution of a polynomial equation. PMID:18928368

  7. Performance Analysis of Cloud Computing Architectures Using Discrete Event Simulation

    NASA Technical Reports Server (NTRS)

    Stocker, John C.; Golomb, Andrew M.

    2011-01-01

    Cloud computing offers the economic benefit of on-demand resource allocation to meet changing enterprise computing needs. However, the flexibility of cloud computing is disadvantaged when compared to traditional hosting in providing predictable application and service performance. Cloud computing relies on resource scheduling in a virtualized network-centric server environment, which makes static performance analysis infeasible. We developed a discrete event simulation model to evaluate the overall effectiveness of organizations in executing their workflow in traditional and cloud computing architectures. The two part model framework characterizes both the demand using a probability distribution for each type of service request as well as enterprise computing resource constraints. Our simulations provide quantitative analysis to design and provision computing architectures that maximize overall mission effectiveness. We share our analysis of key resource constraints in cloud computing architectures and findings on the appropriateness of cloud computing in various applications.

  8. Event-by-event elliptic flow fluctuations from PHOBOS

    DOE PAGES

    Wosiek, Barbara; Alver, B.; Back, B. B.; ...

    2009-04-01

    Recently PHOBOS has focused on the study of fluctuations and correlations in particle production in heavy-ion collisions at the highest energies delivered by the Relativistic Heavy Ion Collider (RHIC). In this report, we present results on event-by-event elliptic flow fluctuations in Au + Au collisions at √s NN =200 GeV. A data-driven method was used to estimate the dominant contribution from non-flow correlations. Over the broad range of collision centralities, the observed large elliptic flow fluctuations are in agreement with the fluctuations in the initial source eccentricity.

  9. Event-by-Event Elliptic Flow Fluctuations from PHOBOS

    NASA Astrophysics Data System (ADS)

    Wosiek, B.; Alver, B.; Back, B. B.; Baker, M. D.; Ballintijn, M.; Barton, D. S.; Betts, R. R.; Bickley, A. A.; Bindel, R.; Busza, W.; Carroll, A.; Chai, Z.; Chetluru, V.; Decowski, M. P.; García, E.; Gburek, T.; George, N.; Gulbrandsen, K.; Halliwell, C.; Hamblen, J.; Harnarine, I.; Hauer, M.; Henderson, C.; Hofman, D. J.; Hollis, R. S.; Hołyński, R.; Holzman, B.; Iordanova, A.; Johnson, E.; Kane, J. L.; Khan, N.; Kulinich, P.; Kuo, C. M.; Li, W.; Lin, W. T.; Loizides, C.; Manly, S.; Mignerey, A. C.; Nouicer, R.; Olszewski, A.; Pak, R.; Reed, C.; Richardson, E.; Roland, C.; Roland, G.; Sagerer, J.; Seals, H.; Sedykh, I.; Smith, C. E.; Stankiewicz, M. A.; Steinberg, P.; Stephans, G. S. F.; Sukhanov, A.; Szostak, A.; Tonjes, M. B.; Trzupek, A.; Vale, C.; van Nieuwenhuizen, G. J.; Vaurynovich, S. S.; Verdier, R.; Veres, G. I.; Walters, P.; Wenger, E.; Willhelm, D.; Wolfs, F. L. H.; Woźniak, K.; Wyngaardt, S.; Wysłouch, B.

    2009-04-01

    Recently PHOBOS has focused on the study of fluctuations and correlations in particle production in heavy-ion collisions at the highest energies delivered by the Relativistic Heavy Ion Collider (RHIC). In this report, we present results on event-by-event elliptic flow fluctuations in (Au+Au) collisions at sqrt {sNN}=200 GeV. A data-driven method was used to estimate the dominant contribution from non-flow correlations. Over the broad range of collision centralities, the observed large elliptic flow fluctuations are in agreement with the fluctuations in the initial source eccentricity.

  10. Polar cap potential saturation during the Bastille Day storm event using global MHD simulation

    NASA Astrophysics Data System (ADS)

    Kubota, Y.; Nagatsuma, T.; Den, M.; Tanaka, T.; Fujita, S.

    2017-04-01

    We investigated the temporal variations and saturation of the cross polar cap potential (CPCP) in the Bastille Day storm event (15 July 2000) by global magnetohydrodynamics (MHD) simulation. The CPCP is considered to depend on the electric field and dynamic pressure of the solar wind as well as on the ionospheric conductivity. Previous studies considered only the ionospheric conductivity due to solar extreme ultraviolet (EUV) variations. In this paper, we dealt with the changes in the CPCP attributable to auroral conductivity variations caused by pressure enhancement in the inner magnetosphere owing to energy injection from the magnetosphere because the energy injection is considerably enhanced in a severe magnetic storm event. Our simulation reveals that the auroral conductivity enhancement is significant for the CPCP variation in a severe magnetic storm event. The numerical results concerning the Bastille Day event show that the ionospheric conductivity averaged over the auroral oval is enhanced up to 18 mho in the case of Bz of less than -59 nT. On the other hand, the average conductivity without the auroral effect is almost 6 mho throughout the entire period. Resultantly, the saturated CPCP is about 240 kV in the former and 704 kV in the latter when Bz is -59 nT. This result indicates that the CPCP variations could be correctly reproduced when the time variation of auroral conductivity caused by pressure enhancement due to the energy injection from the magnetosphere is correctly considered in a severe magnetic storm event.

  11. Numerical Simulations of Slow Stick Slip Events with PFC, a DEM Based Code

    NASA Astrophysics Data System (ADS)

    Ye, S. H.; Young, R. P.

    2017-12-01

    Nonvolcanic tremors around subduction zone have become a fascinating subject in seismology in recent years. Previous studies have shown that the nonvolcanic tremor beneath western Shikoku is composed of low frequency seismic waves overlapping each other. This finding provides direct link between tremor and slow earthquakes. Slow stick slip events are considered to be laboratory scaled slow earthquakes. Slow stick slip events are traditionally studied with direct shear or double direct shear experiment setup, in which the sliding velocity can be controlled to model a range of fast and slow stick slips. In this study, a PFC* model based on double direct shear is presented, with a central block clamped by two side blocks. The gauge layers between the central and side blocks are modelled as discrete fracture networks with smooth joint bonds between pairs of discrete elements. In addition, a second model is presented in this study. This model consists of a cylindrical sample subjected to triaxial stress. Similar to the previous model, a weak gauge layer at a 45 degrees is added into the sample, on which shear slipping is allowed. Several different simulations are conducted on this sample. While the confining stress is maintained at the same level in different simulations, the axial loading rate (displacement rate) varies. By varying the displacement rate, a range of slipping behaviour, from stick slip to slow stick slip are observed based on the stress-strain relationship. Currently, the stick slip and slow stick slip events are strictly observed based on the stress-strain relationship. In the future, we hope to monitor the displacement and velocity of the balls surrounding the gauge layer as a function of time, so as to generate a synthetic seismogram. This will allow us to extract seismic waveforms and potentially simulate the tremor-like waves found around subduction zones. *Particle flow code, a discrete element method based numerical simulation code developed by

  12. What can neuromorphic event-driven precise timing add to spike-based pattern recognition?

    PubMed

    Akolkar, Himanshu; Meyer, Cedric; Clady, Zavier; Marre, Olivier; Bartolozzi, Chiara; Panzeri, Stefano; Benosman, Ryad

    2015-03-01

    This letter introduces a study to precisely measure what an increase in spike timing precision can add to spike-driven pattern recognition algorithms. The concept of generating spikes from images by converting gray levels into spike timings is currently at the basis of almost every spike-based modeling of biological visual systems. The use of images naturally leads to generating incorrect artificial and redundant spike timings and, more important, also contradicts biological findings indicating that visual processing is massively parallel, asynchronous with high temporal resolution. A new concept for acquiring visual information through pixel-individual asynchronous level-crossing sampling has been proposed in a recent generation of asynchronous neuromorphic visual sensors. Unlike conventional cameras, these sensors acquire data not at fixed points in time for the entire array but at fixed amplitude changes of their input, resulting optimally sparse in space and time-pixel individually and precisely timed only if new, (previously unknown) information is available (event based). This letter uses the high temporal resolution spiking output of neuromorphic event-based visual sensors to show that lowering time precision degrades performance on several recognition tasks specifically when reaching the conventional range of machine vision acquisition frequencies (30-60 Hz). The use of information theory to characterize separability between classes for each temporal resolution shows that high temporal acquisition provides up to 70% more information that conventional spikes generated from frame-based acquisition as used in standard artificial vision, thus drastically increasing the separability between classes of objects. Experiments on real data show that the amount of information loss is correlated with temporal precision. Our information-theoretic study highlights the potentials of neuromorphic asynchronous visual sensors for both practical applications and theoretical

  13. The architecture of Newton, a general-purpose dynamics simulator

    NASA Technical Reports Server (NTRS)

    Cremer, James F.; Stewart, A. James

    1989-01-01

    The architecture for Newton, a general-purpose system for simulating the dynamics of complex physical objects, is described. The system automatically formulates and analyzes equations of motion, and performs automatic modification of this system equations when necessitated by changes in kinematic relationships between objects. Impact and temporary contact are handled, although only using simple models. User-directed influence of simulations is achieved using Newton's module, which can be used to experiment with the control of many-degree-of-freedom articulated objects.

  14. Prehistoric land use and Neolithisation in Europe in the context of regional climate events

    NASA Astrophysics Data System (ADS)

    Lemmen, C.; Wirtz, K. W.; Gronenborn, D.

    2009-04-01

    We present a simple, adaptation-driven, spatially explicit model of pre-Bronze age socio-technological change, called the Global Land Use and Technological Evolution Simulator (GLUES). The socio-technological realm is described by three characteristic traits: available technology, subsistence style ratio, and economic diversity. Human population and culture develop in the context of global paleoclimate and regional paleoclimate events. Global paleoclimate is derived from CLIMBER-2 Earth System Model anomalies superimposed on the IIASA temperature and precipitation database. Regional a forcing is provided by abrupt climate deteriorations from a compilation of 138 long-term high-resolution climate proxy time series from mostly terrestrial and near-shore archives. The GLUES simulator provides for a novel way to explore the interplay between climate, climate change, and cultural evolution both on the Holocene timescale as well as for short-term extreme event periods. We sucessfully simulate the migration of people and the diffusion of Neolithic technology from the Near East into Europe in the period 12000-4000 a BP. We find good agreement with recent archeological compilations of Western Eurasian Neolithic sites. No causal relationship between climate events and cultural evolution could be identified, but the speed of cultural development is found to be modulated by the frequency of climate events. From the demographic evolution and regional ressource consumption, we estimate regional land use change and prehistoric greenhouse gas emissions.

  15. Simultaneous Modeling of Gradual SEP Events at the Earth and the Mars

    NASA Astrophysics Data System (ADS)

    Hu, J.; Li, G.

    2017-12-01

    Solar Energetic Particles (SEP) event is the number one space hazard for spacecraft instruments and astronauts' safety. Recent studies have shown that both longitudinal and radial extent of SEP events can be very significant. In this work, we use the improved Particle Acceleration and Transport in the Heliosphere (iPATH) model to simulate gradual SEP events that have impacts upon both the Earth and the Mars. We follow the propagation of a 2D CME-driven shock. Particles are accelerated at the shock via the diffusive shock acceleration (DSA) mechanism. Transport of the escaped particles to the Earth and the Mars is then followed using a backward stochastic differential equation method. Perpendicular diffusion is considered in both the DSA and the transport process. Model results such as time intensity profile and energetic particle spectrum at the two locations are compared to understand the spatial extent of an SEP event. Observational data at the Earth and the Mars are also studied to validate the model.

  16. Global MHD Simulation of the Coronal Mass Ejection on 2011 March 7: from Chromosphere to 1 AU

    NASA Astrophysics Data System (ADS)

    Jin, M.; Manchester, W.; van der Holst, B.; Oran, R.; Sokolov, I.; Toth, G.; Vourlidas, A.; Liu, Y.; Sun, X.; Gombosi, T. I.

    2013-12-01

    In this study, we present magnetohydrodynamics simulation results of a fast CME event that occurred on 2011 March 7 by using the newly developed Alfven Wave Solar Model (AWSoM) in Space Weather Modeling Framework (SWMF). The background solar wind is driven by Alfven-wave pressure and heated by Alfven-wave dissipation in which we have incorporated balanced turbulence at the top of the closed field lines. The magnetic field of the inner boundary is specified with a synoptic magnetogram from SDO/HMI. In order to produce the physically correct CME structures and CME-driven shocks, the electron and proton temperatures are separated so that the electron heat conduction is explicitly treated in conjunction with proton shock heating. Also, collisionless heat conduction is implemented for getting the correct electron temperature at 1 AU. We initiate the CME by using the Gibson-Low flux rope model and simulate the CME propagation to 1 AU. A comprehensive validation study is performed using remote as well as in-situ observations from SOHO, STEREOA/B, ACE, and WIND. Our result shows that the new model can reproduce most of the observed features and the arrival time of the CME is correctly estimated, which suggests the forecasting capability of the new model. We also examine the simulated CME-driven shock structures that are important for modeling the associated solar energetic event (SEP) with diffusive shock acceleration.

  17. How much are Chevrolet Volts in The EV Project driven in EV Mode?

    DOE Office of Scientific and Technical Information (OSTI.GOV)

    Smart, John

    2013-08-01

    This report summarizes key conclusions from analysis of data collected from Chevrolet Volts participating in The EV Project. Topics include how many miles are driven in EV mode, how far vehicles are driven between charging events, and how much energy is charged from the electric grid per charging event.

  18. Data-Driven Simulation-Enhanced Optimization of People-Based Print Production Service

    NASA Astrophysics Data System (ADS)

    Rai, Sudhendu

    This paper describes a systematic six-step data-driven simulation-based methodology for optimizing people-based service systems on a large distributed scale that exhibit high variety and variability. The methodology is exemplified through its application within the printing services industry where it has been successfully deployed by Xerox Corporation across small, mid-sized and large print shops generating over 250 million in profits across the customer value chain. Each step of the methodology consisting of innovative concepts co-development and testing in partnership with customers, development of software and hardware tools to implement the innovative concepts, establishment of work-process and practices for customer-engagement and service implementation, creation of training and infrastructure for large scale deployment, integration of the innovative offering within the framework of existing corporate offerings and lastly the monitoring and deployment of the financial and operational metrics for estimating the return-on-investment and the continual renewal of the offering are described in detail.

  19. Seasonal changes in the atmospheric heat balance simulated by the GISS general circulation model

    NASA Technical Reports Server (NTRS)

    Stone, P. H.; Chow, S.; Helfand, H. M.; Quirk, W. J.; Somerville, R. C. J.

    1975-01-01

    Tests of the ability of numerical general circulation models to simulate the atmosphere have focussed so far on simulations of the January climatology. These models generally present boundary conditions such as sea surface temperature, but this does not prevent testing their ability to simulate seasonal changes in atmospheric processes that accompany presented seasonal changes in boundary conditions. Experiments to simulate changes in the zonally averaged heat balance are discussed since many simplified models of climatic processes are based solely on this balance.

  20. Generalized Sheet Transition Condition FDTD Simulation of Metasurface

    NASA Astrophysics Data System (ADS)

    Vahabzadeh, Yousef; Chamanara, Nima; Caloz, Christophe

    2018-01-01

    We propose an FDTD scheme based on Generalized Sheet Transition Conditions (GSTCs) for the simulation of polychromatic, nonlinear and space-time varying metasurfaces. This scheme consists in placing the metasurface at virtual nodal plane introduced between regular nodes of the staggered Yee grid and inserting fields determined by GSTCs in this plane in the standard FDTD algorithm. The resulting update equations are an elegant generalization of the standard FDTD equations. Indeed, in the limiting case of a null surface susceptibility ($\\chi_\\text{surf}=0$), they reduce to the latter, while in the next limiting case of a time-invariant metasurface $[\\chi_\\text{surf}\